]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update copyright year of all files touched in 2015. 2114/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 24 Jan 2016 21:03:16 +0000 (15:03 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 24 Jan 2016 21:03:16 +0000 (15:03 -0600)
1532 files changed:
bundled/boost-1.56.0/libs/system/src/CMakeLists.txt
cmake/macros/macro_deal_ii_invoke_autopilot.cmake
cmake/macros/macro_enable_if_supported.cmake
cmake/macros/macro_filter_system_libraries.cmake
cmake/macros/macro_register_feature.cmake
cmake/macros/macro_replace_flag.cmake
cmake/macros/macro_strip_flag.cmake
cmake/modules/FindBOOST.cmake
cmake/modules/FindBZIP2.cmake
cmake/modules/FindMPI.cmake
cmake/modules/FindZLIB.cmake
cmake/scripts/expand_instantiations.cc
contrib/CMakeLists.txt
doc/doxygen/code-gallery/CMakeLists.txt
examples/doxygen/theta_timestepping.cc
examples/step-18/step-18.cc
examples/step-4/step-4.cc
examples/step-40/step-40.cc
examples/step-54/step-54.cc
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/polynomials_bdm.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/tensor.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_base.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/grid_refinement.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/intergrid_map.h
include/deal.II/grid/tria.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/fe_collection.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/vector_tools.templates.h
source/algorithms/operator.inst.in
source/base/parallel.cc
source/base/parameter_handler.cc
source/base/polynomial_space.cc
source/base/polynomials_abf.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_p.cc
source/base/polynomials_raviart_thomas.cc
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_const.cc
source/distributed/CMakeLists.txt
source/distributed/shared_tria.inst.in
source/distributed/solution_transfer.inst.in
source/distributed/tria.cc
source/distributed/tria_base.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_handler_policy.inst.in
source/dofs/dof_tools.inst.in
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_data.cc
source/fe/fe_nedelec.cc
source/fe/fe_q_base.inst.in
source/fe/fe_q_bubbles.cc
source/fe/fe_q_bubbles.inst.in
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_system.cc
source/fe/fe_tools.inst.in
source/fe/fe_values_inst2.cc
source/grid/grid_generator.cc
source/grid/grid_in.inst.in
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/intergrid_map.cc
source/grid/tria.cc
source/grid/tria_accessor.inst.in
source/hp/fe_collection.cc
source/hp/fe_values.cc
source/lac/la_vector.inst.in
source/lac/petsc_solver.cc
source/lac/slepc_solver.cc
source/lac/sparse_matrix.cc
source/lac/sparse_matrix_inst2.cc
source/lac/trilinos_sparse_matrix.inst.in
source/lac/vector.inst.in
source/matrix_free/matrix_free.cc
source/matrix_free/matrix_free.inst.in
source/multigrid/CMakeLists.txt
source/multigrid/mg_base.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_level_global_transfer.inst.in
source/multigrid/mg_transfer_matrix_free.inst.in
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
source/numerics/data_out_faces.cc
source/numerics/error_estimator_1d.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
tests/a-framework/build.cc
tests/a-framework/diff.cc
tests/a-framework/passed.cc
tests/a-framework/run.cc
tests/algorithms/theta_01.cc
tests/aniso/anisotropic_crash.cc
tests/aniso/fe_tools.cc
tests/aniso/solution_transfer.cc
tests/base/aligned_vector_01.cc
tests/base/aligned_vector_02.cc
tests/base/aligned_vector_03.cc
tests/base/aligned_vector_04.cc
tests/base/anisotropic_1.cc
tests/base/anisotropic_2.cc
tests/base/auto_derivative_function.cc
tests/base/boost_fusion.cc
tests/base/boost_iostreams_01.cc
tests/base/conditional_ostream.cc
tests/base/convergence_table_01.cc
tests/base/convergence_table_02.cc
tests/base/convergence_table_03.cc
tests/base/convergence_table_04.cc
tests/base/data_out_base.cc
tests/base/data_out_base_tecplot_bin.cc
tests/base/full_tensor_08.cc
tests/base/full_tensor_09.cc
tests/base/full_tensor_10.cc
tests/base/function_derivative.cc
tests/base/function_parser.cc
tests/base/function_parser_03.cc
tests/base/function_parser_04.cc
tests/base/functions_01.cc
tests/base/functions_02.cc
tests/base/functions_03.cc
tests/base/functions_04.cc
tests/base/functions_09.cc
tests/base/functions_singularity.cc
tests/base/geometry_info_2.cc
tests/base/geometry_info_3.cc
tests/base/geometry_info_8.cc
tests/base/graph_coloring_01.cc
tests/base/graph_coloring_02.cc
tests/base/graph_coloring_03.cc
tests/base/graph_coloring_05.cc
tests/base/graph_coloring_06.cc
tests/base/hierarchical.cc
tests/base/index_set_01.cc
tests/base/index_set_04.cc
tests/base/index_set_05.cc
tests/base/index_set_06.cc
tests/base/index_set_07.cc
tests/base/index_set_08.cc
tests/base/index_set_09.cc
tests/base/index_set_11.cc
tests/base/index_set_12.cc
tests/base/index_set_17.cc
tests/base/index_set_18.cc
tests/base/index_set_19.cc
tests/base/index_set_20.cc
tests/base/index_set_20_offset.cc
tests/base/index_set_21.cc
tests/base/index_set_22.cc
tests/base/index_set_23.cc
tests/base/index_set_readwrite_01.cc
tests/base/index_set_readwrite_02.cc
tests/base/index_set_readwrite_03.cc
tests/base/log_infinity.cc
tests/base/log_precision.cc
tests/base/log_width.cc
tests/base/logstream_end.cc
tests/base/logtest.cc
tests/base/memory_consumption_01.cc
tests/base/number_traits_real.cc
tests/base/parallel_accumulate.cc
tests/base/parallel_transform_02.cc
tests/base/point_01.cc
tests/base/polynomial1d.cc
tests/base/polynomial_hermite_interpolation.cc
tests/base/polynomial_lagrange.cc
tests/base/polynomial_lagrange_order.cc
tests/base/polynomial_lagrange_product.cc
tests/base/polynomial_minus_equals.cc
tests/base/polynomial_test.cc
tests/base/polynomials_bdm_01.cc
tests/base/polynomials_bdm_02.cc
tests/base/polynomials_rt.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_selector.cc
tests/base/quadrature_sorted_test.cc
tests/base/quadrature_test.cc
tests/base/reference.cc
tests/base/slice_vector.cc
tests/base/stdcxx1x_vs_stdcxx11.cc
tests/base/symmetric_tensor_08.cc
tests/base/symmetric_tensor_09.cc
tests/base/symmetric_tensor_10.cc
tests/base/symmetric_tensor_20.cc
tests/base/symmetric_tensor_22.cc
tests/base/symmetric_tensor_26.cc
tests/base/table_02.cc
tests/base/table_03.cc
tests/base/table_04.cc
tests/base/table_06.cc
tests/base/table_handler_01.cc
tests/base/table_handler_02.cc
tests/base/table_handler_03.cc
tests/base/table_handler_04.cc
tests/base/table_handler_05.cc
tests/base/table_handler_06.cc
tests/base/table_handler_07.cc
tests/base/table_handler_08.cc
tests/base/table_handler_09.cc
tests/base/table_handler_10.cc
tests/base/table_handler_11.cc
tests/base/table_handler_12.cc
tests/base/task_01.cc
tests/base/task_03.cc
tests/base/task_04.cc
tests/base/task_05.cc
tests/base/task_06.cc
tests/base/task_07.cc
tests/base/task_08.cc
tests/base/tensor_02.cc
tests/base/tensor_03.cc
tests/base/tensor_04.cc
tests/base/tensor_05.cc
tests/base/tensor_06.cc
tests/base/tensor_08.cc
tests/base/tensor_24.cc
tests/base/tensor_26.cc
tests/base/tensor_complex_06.cc
tests/base/thread_local_storage_01.cc
tests/base/thread_local_storage_02.cc
tests/base/thread_local_storage_03.cc
tests/base/thread_local_storage_04.cc
tests/base/thread_validity_07.cc
tests/base/thread_validity_08.cc
tests/base/thread_validity_10.cc
tests/base/thread_validity_12.cc
tests/base/time_stepping_01.cc
tests/base/timer.cc
tests/base/timer_02.cc
tests/base/utilities_02.cc
tests/base/utilities_04.cc
tests/base/utilities_06.cc
tests/base/utilities_07.cc
tests/base/vectorization_02.cc
tests/base/vectorization_03.cc
tests/base/vectorization_04.cc
tests/base/work_stream_01.cc
tests/base/work_stream_02.cc
tests/base/work_stream_04.cc
tests/benchmarks/test_hp/step.cc
tests/benchmarks/test_poisson/poisson.cc
tests/bits/anna_1.cc
tests/bits/anna_2.cc
tests/bits/anna_3.cc
tests/bits/apply_boundary_values_01.cc
tests/bits/apply_boundary_values_02.cc
tests/bits/apply_boundary_values_03.cc
tests/bits/apply_boundary_values_04.cc
tests/bits/block_matrix_array_01.cc
tests/bits/block_sparse_matrix_1.cc
tests/bits/block_sparse_matrix_iterator_01.cc
tests/bits/block_sparse_matrix_iterator_02.cc
tests/bits/block_sparse_matrix_iterator_03.cc
tests/bits/block_sparse_matrix_iterator_05.cc
tests/bits/christian_1.cc
tests/bits/christian_2.cc
tests/bits/chunk_sparse_matrix_01a.cc
tests/bits/chunk_sparse_matrix_06.cc
tests/bits/chunk_sparse_matrix_07.cc
tests/bits/chunk_sparse_matrix_08.cc
tests/bits/chunk_sparse_matrix_11.cc
tests/bits/chunk_sparse_matrix_12.cc
tests/bits/chunk_sparse_matrix_13.cc
tests/bits/chunk_sparse_matrix_14.cc
tests/bits/chunk_sparse_matrix_15.cc
tests/bits/chunk_sparse_matrix_16.cc
tests/bits/chunk_sparse_matrix_iterator_01.cc
tests/bits/chunk_sparse_matrix_iterator_04.cc
tests/bits/chunk_sparse_matrix_iterator_05.cc
tests/bits/chunk_sparse_matrix_iterator_06.cc
tests/bits/chunk_sparse_matrix_iterator_07.cc
tests/bits/chunk_sparse_matrix_iterator_08.cc
tests/bits/chunk_sparse_matrix_iterator_09.cc
tests/bits/chunk_sparse_matrix_iterator_10.cc
tests/bits/chunk_sparse_matrix_vector_01.cc
tests/bits/coarsening_3d.cc
tests/bits/complex_vector_11.cc
tests/bits/complex_vector_24.cc
tests/bits/complex_vector_27.cc
tests/bits/complex_vector_28.cc
tests/bits/complex_vector_29.cc
tests/bits/complex_vector_49.cc
tests/bits/compressed_set_sparsity_pattern_01.cc
tests/bits/compressed_set_sparsity_pattern_02.cc
tests/bits/compressed_set_sparsity_pattern_03.cc
tests/bits/compressed_set_sparsity_pattern_06.cc
tests/bits/compressed_set_sparsity_pattern_07.cc
tests/bits/compressed_set_sparsity_pattern_08.cc
tests/bits/compressed_sparsity_pattern_01.cc
tests/bits/compressed_sparsity_pattern_02.cc
tests/bits/compressed_sparsity_pattern_03.cc
tests/bits/compressed_sparsity_pattern_04.cc
tests/bits/compressed_sparsity_pattern_05.cc
tests/bits/compressed_sparsity_pattern_06.cc
tests/bits/compressed_sparsity_pattern_07.cc
tests/bits/compressed_sparsity_pattern_08.cc
tests/bits/cone_01.cc
tests/bits/cone_02.cc
tests/bits/count_dofs_per_block_01.cc
tests/bits/count_dofs_per_block_02.cc
tests/bits/count_dofs_per_component_hp_01.cc
tests/bits/count_dofs_per_component_hp_02.cc
tests/bits/cylinder_01.cc
tests/bits/cylinder_02.cc
tests/bits/cylinder_03.cc
tests/bits/cylinder_04.cc
tests/bits/cylinder_shell_01.cc
tests/bits/cylinder_shell_02.cc
tests/bits/data_out_07.cc
tests/bits/data_out_08.cc
tests/bits/data_out_09.cc
tests/bits/data_out_common.h
tests/bits/data_out_multi_dh_01.cc
tests/bits/data_out_multi_dh_02.cc
tests/bits/data_out_multi_dh_03.cc
tests/bits/data_out_multi_dh_04.cc
tests/bits/data_out_multi_dh_05.cc
tests/bits/data_out_stack_01.cc
tests/bits/data_out_stack_02.cc
tests/bits/data_out_stack_03.cc
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/bits/denis_1.cc
tests/bits/distorted_cells_01.cc
tests/bits/distorted_cells_02.cc
tests/bits/distorted_cells_07.cc
tests/bits/distorted_mapped_cells_01.cc
tests/bits/distorted_mapped_cells_02.cc
tests/bits/dof_constraints_01.cc
tests/bits/dof_constraints_02.cc
tests/bits/dof_constraints_03.cc
tests/bits/dof_constraints_06.cc
tests/bits/dof_constraints_06_x.cc
tests/bits/dof_constraints_09.cc
tests/bits/dof_constraints_10.cc
tests/bits/dof_constraints_10_x.cc
tests/bits/dof_constraints_11.cc
tests/bits/dof_constraints_11_x.cc
tests/bits/dof_tools_06.cc
tests/bits/dof_tools_13.cc
tests/bits/dof_tools_19.cc
tests/bits/face_orientation_crash.cc
tests/bits/fe_field_function_01.cc
tests/bits/fe_field_function_01_vector.cc
tests/bits/fe_field_function_02.cc
tests/bits/fe_field_function_02_vector.cc
tests/bits/fe_field_function_03.cc
tests/bits/fe_field_function_03_vector.cc
tests/bits/fe_field_function_04_vector.cc
tests/bits/fe_field_function_05_vector.cc
tests/bits/fe_q_3d_01.cc
tests/bits/fe_q_constraints.cc
tests/bits/fe_system.cc
tests/bits/fe_tools_01a.cc
tests/bits/fe_tools_01b.cc
tests/bits/fe_tools_01c.cc
tests/bits/find_cell_1.cc
tests/bits/find_cell_2.cc
tests/bits/find_cell_3.cc
tests/bits/find_cell_6.cc
tests/bits/find_cell_alt_1.cc
tests/bits/find_cell_alt_2.cc
tests/bits/find_cell_alt_3.cc
tests/bits/find_cell_alt_4.cc
tests/bits/find_cell_alt_5.cc
tests/bits/find_cell_alt_6.cc
tests/bits/find_cell_alt_7.cc
tests/bits/find_cells_adjacent_to_vertex_1.cc
tests/bits/find_cells_adjacent_to_vertex_2.cc
tests/bits/find_cells_adjacent_to_vertex_3.cc
tests/bits/find_cells_adjacent_to_vertex_4.cc
tests/bits/find_cells_adjacent_to_vertex_5.cc
tests/bits/find_cells_adjacent_to_vertex_6.cc
tests/bits/find_closest_vertex_1.cc
tests/bits/full_matrix_56.cc
tests/bits/full_matrix_57.cc
tests/bits/full_matrix_common.h
tests/bits/gerold_1.cc
tests/bits/get_dof_indices_01.cc
tests/bits/get_fe_from_name.cc
tests/bits/joa_1.cc
tests/bits/make_boundary_constraints_01.cc
tests/bits/make_boundary_constraints_02.cc
tests/bits/make_boundary_constraints_03.cc
tests/bits/map_dofs_to_support_points_hp_01.cc
tests/bits/map_dofs_to_support_points_hp_02.cc
tests/bits/mapping_cartesian_1.cc
tests/bits/mapping_q1_eulerian_01.cc
tests/bits/mapping_q4_3d.cc
tests/bits/mapping_q_eulerian_01.cc
tests/bits/mapping_q_eulerian_02.cc
tests/bits/mapping_q_eulerian_03.cc
tests/bits/mapping_q_eulerian_04.cc
tests/bits/mapping_q_eulerian_05.cc
tests/bits/max_n_cells_01.cc
tests/bits/max_n_cells_02.cc
tests/bits/multiple_parameter_loop_01.cc
tests/bits/multiple_parameter_loop_02.cc
tests/bits/nedelec_1.cc
tests/bits/neighboring_cells_at_two_faces.cc
tests/bits/normals_1.cc
tests/bits/normals_2.cc
tests/bits/normals_3.cc
tests/bits/normals_4.cc
tests/bits/oliver_01.cc
tests/bits/parameter_handler_1.cc
tests/bits/parameter_handler_10.cc
tests/bits/parameter_handler_11.cc
tests/bits/parameter_handler_12.cc
tests/bits/parameter_handler_13.cc
tests/bits/parameter_handler_13a.cc
tests/bits/parameter_handler_14.cc
tests/bits/parameter_handler_15.cc
tests/bits/parameter_handler_16.cc
tests/bits/parameter_handler_18.cc
tests/bits/parameter_handler_1_exception.cc
tests/bits/parameter_handler_1_include.cc
tests/bits/parameter_handler_1_include_fail.cc
tests/bits/parameter_handler_1a.cc
tests/bits/parameter_handler_2.cc
tests/bits/parameter_handler_21.cc
tests/bits/parameter_handler_2_read_from_string.cc
tests/bits/parameter_handler_3.cc
tests/bits/parameter_handler_4.cc
tests/bits/parameter_handler_4a.cc
tests/bits/parameter_handler_4b.cc
tests/bits/parameter_handler_5.cc
tests/bits/parameter_handler_6.cc
tests/bits/parameter_handler_6_bool.cc
tests/bits/parameter_handler_7.cc
tests/bits/parameter_handler_8.cc
tests/bits/parameter_handler_9.cc
tests/bits/parameter_handler_read_xml_error_01.cc
tests/bits/parameter_handler_write_json.cc
tests/bits/parameter_handler_write_section_1.cc
tests/bits/parameter_handler_write_section_2.cc
tests/bits/parameter_handler_write_section_xml.cc
tests/bits/parameter_handler_write_xml.cc
tests/bits/parsed_function.cc
tests/bits/periodicity_01.cc
tests/bits/periodicity_02.cc
tests/bits/periodicity_03.cc
tests/bits/periodicity_04.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_02.cc
tests/bits/point_inside_2.cc
tests/bits/point_value_01.cc
tests/bits/point_value_02.cc
tests/bits/point_value_hp_01.cc
tests/bits/point_value_hp_02.cc
tests/bits/q_point_sum_1.cc
tests/bits/q_point_sum_2.cc
tests/bits/q_point_sum_3.cc
tests/bits/q_point_sum_4.cc
tests/bits/roy_1.cc
tests/bits/rt_1.cc
tests/bits/serialize_dof_handler.cc
tests/bits/serialize_hp_dof_handler.cc
tests/bits/solution_transfer.cc
tests/bits/solver_01.cc
tests/bits/sparse_lu_decomposition_1.cc
tests/bits/sparse_matrix_02.cc
tests/bits/sparse_matrix_05.cc
tests/bits/sparse_matrix_05a.cc
tests/bits/sparse_matrix_06.cc
tests/bits/sparse_matrix_07.cc
tests/bits/sparse_matrix_iterator_01.cc
tests/bits/sparse_matrix_iterator_02.cc
tests/bits/sparse_matrix_iterator_03.cc
tests/bits/sparse_matrix_iterator_04.cc
tests/bits/sparse_matrix_iterator_05.cc
tests/bits/sparse_matrix_iterator_06.cc
tests/bits/sparse_matrix_iterator_07.cc
tests/bits/sparse_matrix_iterator_08.cc
tests/bits/sparse_matrix_iterator_09.cc
tests/bits/sparse_matrix_iterator_10.cc
tests/bits/sparsity_pattern_01.cc
tests/bits/sparsity_pattern_01_x.cc
tests/bits/sparsity_pattern_iterator_01.cc
tests/bits/step-10-high-order.cc
tests/bits/step-10.cc
tests/bits/step-11.cc
tests/bits/step-2.cc
tests/bits/step-3.cc
tests/bits/step-4.cc
tests/bits/step-5.cc
tests/bits/step-6-racoptimize-2.cc
tests/bits/step-6-racoptimize.cc
tests/bits/step-6.cc
tests/bits/unit_support_points_02.cc
tests/bits/vector_17.cc
tests/bits/vector_27.cc
tests/bits/vector_28.cc
tests/bits/vector_38.cc
tests/bits/vector_48.cc
tests/bits/vector_49.cc
tests/bits/vector_equality_8.cc
tests/bits/volume_1.cc
tests/bits/volume_2.cc
tests/bits/volume_3.cc
tests/bits/volume_4.cc
tests/codim_one/data_out.cc
tests/codim_one/data_out_02.cc
tests/codim_one/data_out_03.cc
tests/codim_one/direction_flag_01.cc
tests/codim_one/direction_flag_02.cc
tests/codim_one/error_estimator_02.cc
tests/codim_one/extract_boundary_mesh_01.cc
tests/codim_one/extract_boundary_mesh_05.cc
tests/codim_one/extract_boundary_mesh_06.cc
tests/codim_one/extract_boundary_mesh_07.cc
tests/codim_one/fe_dgq_prolongation_01.cc
tests/codim_one/fe_values_extractor_01.cc
tests/codim_one/gradients_1.cc
tests/codim_one/grid_in_out.cc
tests/codim_one/grid_in_out_02.cc
tests/codim_one/grid_in_out_03.cc
tests/codim_one/grid_refinement.cc
tests/codim_one/integrate_log.cc
tests/codim_one/integrate_log_2.cc
tests/codim_one/integrate_one_over_r.cc
tests/codim_one/interpolate_boundary_values_01_vector_valued.cc
tests/codim_one/interpolation.cc
tests/codim_one/interpolation_2.cc
tests/codim_one/interpolation_3.cc
tests/codim_one/mapping_03.cc
tests/codim_one/mapping_q1_eulerian.cc
tests/codim_one/mapping_q_eulerian.cc
tests/codim_one/normal_vectors_01.cc
tests/codim_one/projection.cc
tests/codim_one/projection_dgp.cc
tests/codim_one/renumber_component_wise_01.cc
tests/codim_one/solution_transfer_01.cc
tests/codim_one/tensor_matrix_conversion.cc
tests/codim_one/torus_01.cc
tests/distributed_grids/2d_coarse_grid_01.cc
tests/distributed_grids/2d_coarse_grid_02.cc
tests/distributed_grids/2d_coarse_grid_03.cc
tests/distributed_grids/2d_coarse_grid_04.cc
tests/distributed_grids/2d_coarse_grid_x_01.cc
tests/distributed_grids/2d_coarsening_01.cc
tests/distributed_grids/2d_coarsening_02.cc
tests/distributed_grids/2d_coarsening_03.cc
tests/distributed_grids/2d_coarsening_05.cc
tests/distributed_grids/2d_dofhandler_01.cc
tests/distributed_grids/2d_refinement_01.cc
tests/distributed_grids/2d_refinement_02.cc
tests/distributed_grids/2d_refinement_03.cc
tests/distributed_grids/2d_refinement_04.cc
tests/distributed_grids/2d_refinement_05.cc
tests/distributed_grids/2d_refinement_06.cc
tests/distributed_grids/2d_refinement_07.cc
tests/distributed_grids/3d_coarse_grid_01.cc
tests/distributed_grids/3d_coarse_grid_02.cc
tests/distributed_grids/3d_coarse_grid_03.cc
tests/distributed_grids/3d_coarse_grid_04.cc
tests/distributed_grids/3d_coarse_grid_05.cc
tests/distributed_grids/3d_coarse_grid_06.cc
tests/distributed_grids/3d_coarse_grid_x_01.cc
tests/distributed_grids/3d_coarsening_01.cc
tests/distributed_grids/3d_coarsening_02.cc
tests/distributed_grids/3d_coarsening_03.cc
tests/distributed_grids/3d_coarsening_04.cc
tests/distributed_grids/3d_coarsening_05.cc
tests/distributed_grids/3d_refinement_01.cc
tests/distributed_grids/3d_refinement_02.cc
tests/distributed_grids/3d_refinement_03.cc
tests/distributed_grids/3d_refinement_04.cc
tests/distributed_grids/3d_refinement_05.cc
tests/distributed_grids/3d_refinement_06.cc
tests/distributed_grids/3d_refinement_07.cc
tests/distributed_grids/3d_refinement_09.cc
tests/distributed_grids/anisotropic.cc
tests/distributed_grids/codim_01.cc
tests/distributed_grids/count_dofs_per_component_01.cc
tests/distributed_grids/solution_transfer_01.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/distributed_grids/solution_transfer_04.cc
tests/distributed_grids/subdomain_id_01.cc
tests/distributed_grids/tria_settings_01.cc
tests/distributed_grids/update_number_cache_01.cc
tests/dofs/accessor_01.cc
tests/dofs/accessor_02.cc
tests/dofs/dof_accessor_01.cc
tests/dofs/dof_handler_number_cache_02.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_zorder_01.cc
tests/dofs/dof_renumbering_zorder_02.cc
tests/dofs/extract_dofs_by_component_01.cc
tests/dofs/extract_dofs_by_component_01_hp.cc
tests/dofs/extract_dofs_by_component_01_mg.cc
tests/dofs/extract_dofs_by_component_01x.cc
tests/dofs/extract_dofs_by_component_01y.cc
tests/dofs/extract_dofs_by_component_02.cc
tests/dofs/extract_dofs_by_component_02_hp.cc
tests/dofs/extract_dofs_by_component_03.cc
tests/dofs/extract_dofs_by_component_04.cc
tests/dofs/extract_dofs_by_component_05.cc
tests/dofs/extract_dofs_by_component_05_hp.cc
tests/dofs/extract_dofs_by_component_06.cc
tests/dofs/extract_dofs_by_component_06_hp.cc
tests/dofs/interpolate_dgq_01.cc
tests/dofs/interpolate_dgq_02.cc
tests/dofs/interpolate_q_01.cc
tests/dofs/interpolate_q_02.cc
tests/dofs/interpolate_q_system_01.cc
tests/dofs/interpolate_q_system_02.cc
tests/dofs/locally_relevant_dofs_per_subdomain_01.cc
tests/dofs/range_based_for_step-6.cc
tests/dofs/sparsity_pattern_02.cc
tests/dofs/sparsity_pattern_03.cc
tests/dofs/sparsity_pattern_04.cc
tests/dofs/sparsity_pattern_05.cc
tests/dofs/sparsity_pattern_05_x.cc
tests/fail/fe_nothing_04.cc
tests/fail/rt_4.cc
tests/fail/rt_6.cc
tests/fail/rt_crash_01.cc
tests/fail/vectors_boundary_rhs_hp_02.cc
tests/fail/vectors_rhs_hp_02.cc
tests/fe/bdm_10.cc
tests/fe/bdm_11.cc
tests/fe/bdm_12.cc
tests/fe/bdm_13.cc
tests/fe/bdm_14.cc
tests/fe/bdm_15.cc
tests/fe/bdm_2.cc
tests/fe/bdm_3.cc
tests/fe/bdm_5.cc
tests/fe/bdm_8.cc
tests/fe/bdm_9.cc
tests/fe/block_mask_02.cc
tests/fe/block_mask_06.cc
tests/fe/block_mask_07.cc
tests/fe/cell_similarity_crash_01.cc
tests/fe/cell_similarity_crash_02.cc
tests/fe/component_mask_06.cc
tests/fe/component_mask_07.cc
tests/fe/component_mask_14.cc
tests/fe/copy_01.cc
tests/fe/crash_01.cc
tests/fe/curl_curl_01.cc
tests/fe/derivatives.cc
tests/fe/derivatives_face.cc
tests/fe/dgp_monomial_1.cc
tests/fe/dgp_monomial_2.cc
tests/fe/dgq_1.cc
tests/fe/element_constant_modes.cc
tests/fe/face_to_cell_q1_2d.cc
tests/fe/face_to_cell_q2_2d.cc
tests/fe/face_to_cell_q2xq2_2d.cc
tests/fe/face_to_cell_q3_2d.cc
tests/fe/face_to_cell_q3xq4_2d.cc
tests/fe/face_to_cell_q4_2d.cc
tests/fe/fe_data_test.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_face_values_1d_mapping_cartesian.cc
tests/fe/fe_face_values_1d_mapping_q2.cc
tests/fe/fe_prolongation_common.h
tests/fe/fe_prolongation_q_bubbles.cc
tests/fe/fe_q_01.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_restriction_common.h
tests/fe/fe_restriction_q_bubbles.cc
tests/fe/fe_support_points_common.h
tests/fe/fe_support_points_q_bubbles.cc
tests/fe/fe_tools.cc
tests/fe/fe_tools_block_renumbering.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_extractor_01.cc
tests/fe/fe_values_view_01.cc
tests/fe/fe_values_view_03.cc
tests/fe/fe_values_view_05.cc
tests/fe/fe_values_view_06.cc
tests/fe/fe_values_view_07.cc
tests/fe/fe_values_view_08.cc
tests/fe/fe_values_view_09.cc
tests/fe/fe_values_view_10.cc
tests/fe/fe_values_view_10_single_01.cc
tests/fe/fe_values_view_10_single_02.cc
tests/fe/fe_values_view_10_single_03.cc
tests/fe/fe_values_view_10_single_04.cc
tests/fe/fe_values_view_11.cc
tests/fe/fe_values_view_12.cc
tests/fe/fe_values_view_13.cc
tests/fe/fe_values_view_14.cc
tests/fe/fe_values_view_15.cc
tests/fe/fe_values_view_16.cc
tests/fe/fe_values_view_17.cc
tests/fe/fe_values_view_21.cc
tests/fe/fe_values_view_21_nonsymmetric.cc
tests/fe/fe_values_view_23.cc
tests/fe/fe_values_view_23_nonsymmetric.cc
tests/fe/fe_values_view_24.cc
tests/fe/fe_values_view_24_nonsymmetric.cc
tests/fe/fe_values_view_25.cc
tests/fe/fe_values_view_25_nonsymmetric.cc
tests/fe/fe_values_view_26.cc
tests/fe/fe_values_view_27.cc
tests/fe/fe_values_view_30.cc
tests/fe/fe_values_view_invalid_01.cc
tests/fe/fe_values_view_invalid_02.cc
tests/fe/fe_values_view_invalid_03.cc
tests/fe/fe_values_view_invalid_03_nonsymmetric.cc
tests/fe/get_dof_association.cc
tests/fe/get_fe_from_name_01.cc
tests/fe/get_name_01.cc
tests/fe/get_name_02.cc
tests/fe/interpolate_common.h
tests/fe/interpolate_q1.cc
tests/fe/interpolate_q_bubbles.cc
tests/fe/interpolate_q_dg0.cc
tests/fe/interpolate_q_iso_q1.cc
tests/fe/interpolate_rt.cc
tests/fe/interpolate_rtn.cc
tests/fe/interpolate_system.cc
tests/fe/jacobians.cc
tests/fe/mapping_q1_eulerian.cc
tests/fe/mapping_q_eulerian.cc
tests/fe/mass_matrix_arbitrary_nodes.cc
tests/fe/nedelec.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_3.cc
tests/fe/nedelec_crash_01.cc
tests/fe/nedelec_crash_hp.cc
tests/fe/nedelec_face_interpolation.cc
tests/fe/q_1.cc
tests/fe/q_2.cc
tests/fe/q_3.cc
tests/fe/q_4.cc
tests/fe/q_bubbles_projection_01.cc
tests/fe/restrict_prolongation_01.cc
tests/fe/rt_1.cc
tests/fe/rt_10.cc
tests/fe/rt_11.cc
tests/fe/rt_12.cc
tests/fe/rt_13.cc
tests/fe/rt_14.cc
tests/fe/rt_15.cc
tests/fe/rt_2.cc
tests/fe/rt_3.cc
tests/fe/rt_5.cc
tests/fe/rt_7.cc
tests/fe/rt_8.cc
tests/fe/rt_9.cc
tests/fe/rt_covariant.cc
tests/fe/rt_hessian.cc
tests/fe/rtdiff.cc
tests/fe/rtn_1.cc
tests/fe/rtn_2.cc
tests/fe/rtn_3.cc
tests/fe/shapes_dgp.cc
tests/fe/shapes_dgp_monomial.cc
tests/fe/shapes_dgp_nonparametric.cc
tests/fe/shapes_dgq.cc
tests/fe/shapes_nedelec.cc
tests/fe/shapes_q.cc
tests/fe/shapes_q_bubbles.cc
tests/fe/shapes_q_dg0.cc
tests/fe/shapes_q_hierarchical.cc
tests/fe/shapes_q_iso_q1.cc
tests/fe/system_01.cc
tests/fe/system_02.cc
tests/fe/system_index.cc
tests/fe/traits.cc
tests/gla/block_mat_01.cc
tests/gla/block_vec_01.cc
tests/gla/block_vec_02.cc
tests/gla/block_vec_03.cc
tests/gla/block_vec_04.cc
tests/gla/mat_01.cc
tests/gla/mat_02.cc
tests/gla/vec_03.cc
tests/gla/vec_04.cc
tests/gla/vec_05.cc
tests/gla/vec_06.cc
tests/gla/vec_07.cc
tests/grid/distort_random.cc
tests/grid/extent_in_direction.cc
tests/grid/flatten_grid_01.cc
tests/grid/grid_generator_01a.cc
tests/grid/grid_generator_02.cc
tests/grid/grid_generator_03.cc
tests/grid/grid_generator_04.cc
tests/grid/grid_generator_05.cc
tests/grid/grid_generator_09.cc
tests/grid/grid_hyper_shell_02.cc
tests/grid/grid_hyper_shell_03.cc
tests/grid/grid_hyper_shell_04.cc
tests/grid/grid_in.cc
tests/grid/grid_in_3d.cc
tests/grid/grid_in_3d_02.cc
tests/grid/grid_in_abaqus_01.cc
tests/grid/grid_in_gmsh_01.cc
tests/grid/grid_in_gmsh_02.cc
tests/grid/grid_in_msh.cc
tests/grid/grid_in_msh_02.cc
tests/grid/grid_in_msh_03.cc
tests/grid/grid_in_msh_version_1.cc
tests/grid/grid_in_msh_version_2.cc
tests/grid/grid_in_tecplot.cc
tests/grid/grid_in_unv_2d.cc
tests/grid/grid_in_unv_3d.cc
tests/grid/grid_in_vtk_2d.cc
tests/grid/grid_in_vtk_3d.cc
tests/grid/grid_in_vtk_3d_02.cc
tests/grid/grid_in_vtk_3d_03.cc
tests/grid/grid_invert.cc
tests/grid/grid_out.cc
tests/grid/grid_out_02.cc
tests/grid/grid_out_svg_02.cc
tests/grid/grid_output_input.cc
tests/grid/grid_parallelepiped.cc
tests/grid/grid_parallelepiped_01.cc
tests/grid/grid_parallelepiped_02.cc
tests/grid/grid_parallelepiped_03.cc
tests/grid/grid_tools.cc
tests/grid/grid_tools_02.cc
tests/grid/grid_tools_03.cc
tests/grid/grid_tools_04.cc
tests/grid/grid_tools_transform_01.cc
tests/grid/grid_transform_02.cc
tests/grid/intergrid_constraints.cc
tests/grid/intergrid_map.cc
tests/grid/line_coarsening_3d.cc
tests/grid/maximal_cell_diameter.cc
tests/grid/measure_et_al.cc
tests/grid/measure_et_al_02.cc
tests/grid/measure_of_3d_face_01.cc
tests/grid/merge_triangulations_01.cc
tests/grid/mesh_3d_1.cc
tests/grid/mesh_3d_12.cc
tests/grid/mesh_3d_16.cc
tests/grid/mesh_3d_17.cc
tests/grid/mesh_3d_19.cc
tests/grid/mesh_3d_2.cc
tests/grid/mesh_3d_22.cc
tests/grid/mesh_3d_23.cc
tests/grid/mesh_3d_24.cc
tests/grid/mesh_3d_25.cc
tests/grid/mesh_3d_26.cc
tests/grid/mesh_3d_4.cc
tests/grid/mesh_3d_5.cc
tests/grid/mesh_smoothing_03.cc
tests/grid/minimal_cell_diameter.cc
tests/grid/normal_vector_03.cc
tests/grid/normal_vector_03_2d.cc
tests/grid/normals_at_vertices_01.cc
tests/grid/normals_at_vertices_02.cc
tests/grid/number_cache_01.cc
tests/grid/number_cache_02.cc
tests/grid/number_cache_03.cc
tests/grid/refine_and_coarsen_01.cc
tests/grid/refinement_listener_02.cc
tests/grid/refinement_listener_03.cc
tests/grid/subcelldata.cc
tests/grid/tria_iterator_with_one_header.cc
tests/grid/tria_last.cc
tests/grid/union_triangulation.cc
tests/grid/vertex_as_face_01.cc
tests/grid/vertex_as_face_02.cc
tests/grid/vertex_as_face_03.cc
tests/grid/vertex_as_face_05.cc
tests/grid/vertex_as_face_06.cc
tests/grid/vertex_as_face_07.cc
tests/grid/vertex_as_face_12.cc
tests/grid/vertex_as_face_13.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/continuous_1d_01.cc
tests/hp/continuous_2d_01.cc
tests/hp/continuous_3d_01.cc
tests/hp/copy_tria_bug.cc
tests/hp/count_dofs_per_block_01.cc
tests/hp/count_dofs_per_block_02.cc
tests/hp/crash_01.cc
tests/hp/crash_02.cc
tests/hp/crash_03.cc
tests/hp/crash_04.cc
tests/hp/crash_05.cc
tests/hp/crash_06.cc
tests/hp/crash_07.cc
tests/hp/crash_08.cc
tests/hp/crash_09.cc
tests/hp/crash_10.cc
tests/hp/crash_11.cc
tests/hp/crash_12.cc
tests/hp/crash_14.cc
tests/hp/crash_16.cc
tests/hp/crash_17.cc
tests/hp/crash_17_compressed_set_sparsity.cc
tests/hp/crash_18.cc
tests/hp/crash_18_compressed_set_sparsity.cc
tests/hp/crash_19.cc
tests/hp/crash_20.cc
tests/hp/crash_21.cc
tests/hp/create_laplace_matrix_constraints_02.cc
tests/hp/create_laplace_matrix_constraints_02b.cc
tests/hp/create_mass_matrix_constraints_02.cc
tests/hp/create_mass_matrix_constraints_02b.cc
tests/hp/do_function_derivatives_01.cc
tests/hp/do_function_hessians_01.cc
tests/hp/do_function_laplacians_01.cc
tests/hp/fe_collection_01.cc
tests/hp/fe_collection_04.cc
tests/hp/fe_nothing_01.cc
tests/hp/fe_nothing_02.cc
tests/hp/fe_nothing_03.cc
tests/hp/fe_nothing_05.cc
tests/hp/fe_nothing_06.cc
tests/hp/fe_nothing_07.cc
tests/hp/fe_nothing_08.cc
tests/hp/fe_nothing_09.cc
tests/hp/fe_nothing_10.cc
tests/hp/fe_nothing_11.cc
tests/hp/fe_nothing_12.cc
tests/hp/fe_nothing_13.cc
tests/hp/fe_nothing_14.cc
tests/hp/fe_nothing_15.cc
tests/hp/fe_nothing_16.cc
tests/hp/fe_nothing_17.cc
tests/hp/fe_nothing_19.cc
tests/hp/fe_nothing_20.cc
tests/hp/fe_nothing_21.cc
tests/hp/get_active_fe_indices.cc
tests/hp/get_interpolated_dof_values_01.cc
tests/hp/get_interpolated_dof_values_03.cc
tests/hp/hp_dof_handler.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/hp_hanging_nodes_02.cc
tests/hp/hp_line_dof_identities_dgp.cc
tests/hp/hp_line_dof_identities_dgp_monomial.cc
tests/hp/hp_line_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_line_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_line_dof_identities_dgp_nonparametric.cc
tests/hp/hp_line_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_line_dof_identities_dgp_system_01.cc
tests/hp/hp_line_dof_identities_dgp_system_02.cc
tests/hp/hp_line_dof_identities_dgq.cc
tests/hp/hp_line_dof_identities_dgq_system_01.cc
tests/hp/hp_line_dof_identities_dgq_system_02.cc
tests/hp/hp_line_dof_identities_q.cc
tests/hp/hp_line_dof_identities_q_gl.cc
tests/hp/hp_line_dof_identities_q_system_01.cc
tests/hp/hp_line_dof_identities_q_system_02.cc
tests/hp/hp_line_dof_identities_q_system_03.cc
tests/hp/hp_line_dof_identities_rt_nodal.cc
tests/hp/hp_quad_dof_identities_dgp.cc
tests/hp/hp_quad_dof_identities_dgp_monomial.cc
tests/hp/hp_quad_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric_system_02.cc
tests/hp/hp_quad_dof_identities_dgp_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_system_02.cc
tests/hp/hp_quad_dof_identities_dgq.cc
tests/hp/hp_quad_dof_identities_dgq_system_01.cc
tests/hp/hp_quad_dof_identities_dgq_system_02.cc
tests/hp/hp_quad_dof_identities_q.cc
tests/hp/hp_quad_dof_identities_q_gl.cc
tests/hp/hp_quad_dof_identities_q_system_01.cc
tests/hp/hp_quad_dof_identities_q_system_02.cc
tests/hp/hp_quad_dof_identities_rt_nodal.cc
tests/hp/hp_vertex_dof_identities_dgp.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric_system_02.cc
tests/hp/hp_vertex_dof_identities_dgp_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_system_02.cc
tests/hp/hp_vertex_dof_identities_dgq.cc
tests/hp/hp_vertex_dof_identities_dgq_system_01.cc
tests/hp/hp_vertex_dof_identities_dgq_system_02.cc
tests/hp/hp_vertex_dof_identities_q.cc
tests/hp/hp_vertex_dof_identities_q_system_01.cc
tests/hp/hp_vertex_dof_identities_q_system_02.cc
tests/hp/hp_vertex_dof_identities_rt_nodal.cc
tests/hp/integrate_difference.cc
tests/hp/interpolate_nothing_01.cc
tests/hp/interpolate_nothing_02.cc
tests/hp/interpolate_q_system_01.cc
tests/hp/interpolate_q_system_02.cc
tests/hp/mapping_collection_01.cc
tests/hp/mapping_collection_02.cc
tests/hp/mapping_collection_03.cc
tests/hp/mapping_collection_04.cc
tests/hp/n_active_fe_indices.cc
tests/hp/n_boundary_dofs.cc
tests/hp/n_dofs.cc
tests/hp/project_01.cc
tests/hp/project_02.cc
tests/hp/q_collection_01.cc
tests/hp/q_vs_dgq.cc
tests/hp/random.cc
tests/hp/set_dof_values_by_interpolation_01.cc
tests/hp/set_dof_values_by_interpolation_03.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_02.cc
tests/hp/solution_transfer_03.cc
tests/hp/solution_transfer_04.cc
tests/hp/solution_transfer_05.cc
tests/hp/solution_transfer_10.cc
tests/hp/solution_transfer_11.cc
tests/hp/step-10.cc
tests/hp/step-11.cc
tests/hp/step-11_compressed_set_sparsity.cc
tests/hp/step-2.cc
tests/hp/step-3.cc
tests/hp/step-3a.cc
tests/hp/step-3b.cc
tests/hp/step-3c.cc
tests/hp/step-4.cc
tests/hp/step-5.cc
tests/hp/step-6.cc
tests/hp/vectors_boundary_rhs_01.cc
tests/hp/vectors_boundary_rhs_02.cc
tests/hp/vectors_boundary_rhs_03.cc
tests/hp/vectors_boundary_rhs_hp_01.cc
tests/hp/vectors_boundary_rhs_hp_03.cc
tests/hp/vectors_point_source_01.cc
tests/hp/vectors_point_source_hp_01.cc
tests/hp/vectors_rhs_01.cc
tests/hp/vectors_rhs_02.cc
tests/hp/vectors_rhs_03.cc
tests/hp/vectors_rhs_hp_01.cc
tests/hp/vectors_rhs_hp_03.cc
tests/integrators/assembler_simple_mgmatrix_01.cc
tests/lac/bicgstab_large.cc
tests/lac/block_compressed_01.cc
tests/lac/block_compressed_simple_sparsity_pattern_indexset_01.cc
tests/lac/block_matrices.cc
tests/lac/block_matrices_02.cc
tests/lac/block_matrices_03.cc
tests/lac/block_matrices_04.cc
tests/lac/block_sparsity_pattern_01.cc
tests/lac/block_sparsity_pattern_02.cc
tests/lac/block_vector.cc
tests/lac/chunk_sparsity_pattern_01.cc
tests/lac/chunk_sparsity_pattern_02.cc
tests/lac/chunk_sparsity_pattern_03.cc
tests/lac/chunk_sparsity_pattern_04.cc
tests/lac/chunk_sparsity_pattern_05.cc
tests/lac/chunk_sparsity_pattern_06.cc
tests/lac/chunk_sparsity_pattern_07.cc
tests/lac/chunk_sparsity_pattern_08.cc
tests/lac/chunk_sparsity_pattern_09.cc
tests/lac/chunk_sparsity_pattern_10.cc
tests/lac/chunk_sparsity_pattern_11.cc
tests/lac/complex_block_vector.cc
tests/lac/compressed_set_sparsity_pattern_01.cc
tests/lac/compressed_set_sparsity_pattern_02.cc
tests/lac/compressed_set_sparsity_pattern_03.cc
tests/lac/compressed_set_sparsity_pattern_04.cc
tests/lac/compressed_set_sparsity_pattern_05.cc
tests/lac/compressed_set_sparsity_pattern_10.cc
tests/lac/compressed_set_sparsity_pattern_11.cc
tests/lac/compressed_simple_sparsity_pattern_01.cc
tests/lac/compressed_simple_sparsity_pattern_02.cc
tests/lac/compressed_simple_sparsity_pattern_03.cc
tests/lac/compressed_simple_sparsity_pattern_04.cc
tests/lac/compressed_simple_sparsity_pattern_05.cc
tests/lac/compressed_simple_sparsity_pattern_10.cc
tests/lac/compressed_simple_sparsity_pattern_11.cc
tests/lac/compressed_simple_sparsity_pattern_index_set_01.cc
tests/lac/compressed_simple_sparsity_pattern_index_set_02.cc
tests/lac/compressed_sparsity_pattern_01.cc
tests/lac/compressed_sparsity_pattern_02.cc
tests/lac/compressed_sparsity_pattern_03.cc
tests/lac/compressed_sparsity_pattern_04.cc
tests/lac/compressed_sparsity_pattern_05.cc
tests/lac/compressed_sparsity_pattern_10.cc
tests/lac/compressed_sparsity_pattern_11.cc
tests/lac/constraint_graph.cc
tests/lac/constraint_graph_zero.cc
tests/lac/constraints.cc
tests/lac/constraints_01.cc
tests/lac/constraints_02.cc
tests/lac/constraints_c1.cc
tests/lac/constraints_c1_02.cc
tests/lac/constraints_inhomogeneous.cc
tests/lac/constraints_merge.cc
tests/lac/constraints_merge_02.cc
tests/lac/constraints_merge_03.cc
tests/lac/constraints_merge_04.cc
tests/lac/constraints_merge_05.cc
tests/lac/constraints_merge_06.cc
tests/lac/constraints_merge_07.cc
tests/lac/constraints_merge_08.cc
tests/lac/constraints_merge_09.cc
tests/lac/constraints_zero.cc
tests/lac/constraints_zero_condense.cc
tests/lac/constraints_zero_merge.cc
tests/lac/copy_transposed.cc
tests/lac/eigen.cc
tests/lac/full_matrix.cc
tests/lac/full_matrix_04.cc
tests/lac/full_matrix_07.cc
tests/lac/full_matrix_08.cc
tests/lac/full_matrix_print.cc
tests/lac/gmres_eigenvalues.cc
tests/lac/gmres_reorthogonalize_01.cc
tests/lac/gmres_reorthogonalize_02.cc
tests/lac/gmres_reorthogonalize_03.cc
tests/lac/gmres_reorthogonalize_04.cc
tests/lac/gmres_reorthogonalize_05.cc
tests/lac/householder.cc
tests/lac/identity_matrix_01.cc
tests/lac/identity_matrix_02.cc
tests/lac/identity_matrix_03.cc
tests/lac/identity_matrix_04.cc
tests/lac/identity_matrix_05.cc
tests/lac/identity_matrix_06.cc
tests/lac/inhomogeneous_constraints_02.cc
tests/lac/inhomogeneous_constraints_03.cc
tests/lac/inhomogeneous_constraints_04.cc
tests/lac/inhomogeneous_constraints_block.cc
tests/lac/inhomogeneous_constraints_nonsymmetric.cc
tests/lac/is_block_vector.cc
tests/lac/la_vector_add_and_dot.cc
tests/lac/lapack_fill.cc
tests/lac/linear_operator_01b.cc
tests/lac/linear_operator_01c.cc
tests/lac/linear_operator_08.cc
tests/lac/matrices.cc
tests/lac/matrices_ez.cc
tests/lac/matrices_ez_add.cc
tests/lac/matrices_lapack.cc
tests/lac/matrices_lapack_fill.cc
tests/lac/matrix_lib.cc
tests/lac/matrix_out.cc
tests/lac/pointer_matrix.cc
tests/lac/pointer_matrix_01.cc
tests/lac/pointer_matrix_02.cc
tests/lac/pointer_matrix_03.cc
tests/lac/pointer_matrix_04.cc
tests/lac/pointer_matrix_05.cc
tests/lac/pointer_matrix_06.cc
tests/lac/pointer_matrix_07.cc
tests/lac/pointer_matrix_08.cc
tests/lac/pointer_matrix_09.cc
tests/lac/pointer_matrix_10.cc
tests/lac/pointer_matrix_vector.cc
tests/lac/precondition_chebyshev_01.cc
tests/lac/print_formatted_ez_01.cc
tests/lac/product_matrix_01.cc
tests/lac/product_matrix_02.cc
tests/lac/product_matrix_03.cc
tests/lac/product_matrix_04.cc
tests/lac/product_matrix_05.cc
tests/lac/product_matrix_06.cc
tests/lac/product_matrix_07.cc
tests/lac/product_matrix_08.cc
tests/lac/schur_complement_01.cc
tests/lac/schur_complement_02.cc
tests/lac/schur_complement_03.cc
tests/lac/schur_matrix_01.cc
tests/lac/schur_matrix_02.cc
tests/lac/schur_matrix_03.cc
tests/lac/schur_matrix_04.cc
tests/lac/shifted_matrix_01.cc
tests/lac/shifted_matrix_02.cc
tests/lac/shifted_matrix_03.cc
tests/lac/shifted_matrix_04.cc
tests/lac/shifted_matrix_05.cc
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_monitor.cc
tests/lac/solver_monitor_disconnect.cc
tests/lac/solver_relaxation_01.cc
tests/lac/solver_relaxation_02.cc
tests/lac/solver_relaxation_03.cc
tests/lac/solver_selector_00.cc
tests/lac/solver_selector_01.cc
tests/lac/sparse_ilu_inverse.cc
tests/lac/sparse_matrix_iterator.cc
tests/lac/sparsity_pattern_01.cc
tests/lac/sparsity_pattern_02.cc
tests/lac/sparsity_pattern_03.cc
tests/lac/sparsity_pattern_04.cc
tests/lac/sparsity_pattern_05.cc
tests/lac/sparsity_pattern_06.cc
tests/lac/sparsity_pattern_07.cc
tests/lac/sparsity_pattern_08.cc
tests/lac/sparsity_pattern_09.cc
tests/lac/sparsity_pattern_10.cc
tests/lac/sparsity_pattern_11.cc
tests/lac/sparsity_pattern_12.cc
tests/lac/sparsity_pattern_copy_from.cc
tests/lac/trace.cc
tests/lac/tridiagonal_matrix.cc
tests/lac/tridiagonal_matrix_sym.cc
tests/lac/vector_accumulation_02.cc
tests/lac/vector_add_and_dot.cc
tests/lac/vector_memory.cc
tests/lac/vector_view.cc
tests/lac/vector_view_01.cc
tests/lac/vector_view_02.cc
tests/lac/vector_view_03.cc
tests/lac/vector_view_04.cc
tests/lac/vector_view_05.cc
tests/lapack/full_matrix_01.cc
tests/lapack/full_matrix_02.cc
tests/lapack/full_matrix_03.cc
tests/lapack/full_matrix_04.cc
tests/lapack/full_matrix_05.cc
tests/lapack/full_matrix_06.cc
tests/lapack/full_matrix_07.cc
tests/lapack/full_matrix_08.cc
tests/lapack/full_matrix_09.cc
tests/lapack/full_matrix_10.cc
tests/lapack/full_matrix_11.cc
tests/lapack/full_matrix_12.cc
tests/lapack/solver_cg.cc
tests/lapack/tridiagonal_ev1.cc
tests/matrix_free/assemble_matrix_01.cc
tests/matrix_free/assemble_matrix_02.cc
tests/matrix_free/compress_constraints.cc
tests/matrix_free/compress_mapping.cc
tests/matrix_free/copy.cc
tests/matrix_free/copy_feevaluation.cc
tests/matrix_free/estimate_condition_number_mass.cc
tests/matrix_free/evaluate_1d_shape.cc
tests/matrix_free/evaluate_1d_shape_evenodd.cc
tests/matrix_free/fe_evaluation_access_1d.cc
tests/matrix_free/get_functions_gl.cc
tests/matrix_free/get_functions_mappingq.cc
tests/matrix_free/get_functions_multife.cc
tests/matrix_free/get_functions_multife2.cc
tests/matrix_free/get_functions_q_hierarchical.cc
tests/matrix_free/get_functions_rect.cc
tests/matrix_free/get_functions_variants.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/inverse_mass_02.cc
tests/matrix_free/inverse_mass_03.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_18.cc
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_div.cc
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/matrix_free/matrix_vector_stokes_qdg0.cc
tests/matrix_free/no_index_initialize.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_adaptive.cc
tests/matrix_free/parallel_multigrid_adaptive_mf.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/quadrature_points.cc
tests/matrix_free/step-48b.cc
tests/matrix_free/thread_correctness.cc
tests/matrix_free/thread_correctness_hp.cc
tests/matrix_free/update_mapping_only.cc
tests/metis/metis_01.cc
tests/metis/metis_01a.cc
tests/metis/metis_02.cc
tests/metis/metis_03.cc
tests/mpi/codim_01.cc
tests/mpi/communicate_moved_vertices_01.cc
tests/mpi/compute_mean_value.cc
tests/mpi/condense_01.cc
tests/mpi/constraint_matrix_crash_01.cc
tests/mpi/constraint_matrix_set_zero_01.cc
tests/mpi/constraint_matrix_set_zero_02.cc
tests/mpi/constraint_matrix_trilinos_bug.cc
tests/mpi/count_dofs_per_block_01.cc
tests/mpi/crash_01.cc
tests/mpi/crash_02.cc
tests/mpi/crash_04.cc
tests/mpi/crash_05.cc
tests/mpi/crash_06.cc
tests/mpi/cuthill_mckee_01.cc
tests/mpi/derivative_approximation_01.cc
tests/mpi/derivative_approximation_02.cc
tests/mpi/extract_constant_modes_01.cc
tests/mpi/extract_constant_modes_02.cc
tests/mpi/extract_locally_active_dofs.cc
tests/mpi/find_active_cell_around_point_01.cc
tests/mpi/ghost_02.cc
tests/mpi/has_active_dofs_01.cc
tests/mpi/has_active_dofs_02.cc
tests/mpi/integrate_difference.cc
tests/mpi/interpolate_02.cc
tests/mpi/interpolate_03.cc
tests/mpi/is_locally_owned.cc
tests/mpi/mg_01.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/p4est_2d_coarse_01.cc
tests/mpi/p4est_2d_constraintmatrix_01.cc
tests/mpi/p4est_2d_constraintmatrix_02.cc
tests/mpi/p4est_2d_constraintmatrix_03.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_2d_constraintmatrix_05.cc
tests/mpi/p4est_2d_dofhandler_01.cc
tests/mpi/p4est_2d_dofhandler_02.cc
tests/mpi/p4est_2d_dofhandler_03.cc
tests/mpi/p4est_2d_dofhandler_04.cc
tests/mpi/p4est_2d_dofhandler_05.cc
tests/mpi/p4est_2d_refine_01.cc
tests/mpi/p4est_2d_refine_02.cc
tests/mpi/p4est_2d_refine_03.cc
tests/mpi/p4est_2d_renumber_01.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_2d_simple.cc
tests/mpi/p4est_3d_constraintmatrix_01.cc
tests/mpi/p4est_3d_constraintmatrix_02.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/p4est_3d_refine_01.cc
tests/mpi/p4est_3d_refine_02.cc
tests/mpi/p4est_3d_refine_03.cc
tests/mpi/p4est_3d_refine_04.cc
tests/mpi/p4est_data_out_01.cc
tests/mpi/p4est_get_subdomain_association.cc
tests/mpi/p4est_max_refine.cc
tests/mpi/p4est_save_01.cc
tests/mpi/p4est_save_02.cc
tests/mpi/p4est_save_04.cc
tests/mpi/parallel_vtu_01.cc
tests/mpi/periodicity_03.cc
tests/mpi/petsc_02.cc
tests/mpi/point_value_01.cc
tests/mpi/refine_and_coarsen_fixed_fraction_02.cc
tests/mpi/refine_and_coarsen_fixed_fraction_04.cc
tests/mpi/refine_and_coarsen_fixed_fraction_05.cc
tests/mpi/refine_and_coarsen_fixed_fraction_06.cc
tests/mpi/refine_and_coarsen_fixed_number_01.cc
tests/mpi/refine_and_coarsen_fixed_number_02.cc
tests/mpi/refine_and_coarsen_fixed_number_03.cc
tests/mpi/refine_and_coarsen_fixed_number_04.cc
tests/mpi/refine_and_coarsen_fixed_number_05.cc
tests/mpi/refine_and_coarsen_fixed_number_06.cc
tests/mpi/refinement_listener_01.cc
tests/mpi/refinement_listener_02.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/renumber_z_order_01.cc
tests/mpi/solution_transfer_01.cc
tests/mpi/tria_01.cc
tests/mpi/tria_copy_triangulation.cc
tests/mpi/trilinos_distribute_03.cc
tests/mpi/trilinos_distribute_04.cc
tests/multigrid/smoother_block.cc
tests/multigrid/transfer_prebuilt_04.cc
tests/numerics/boundaries.cc
tests/numerics/create_laplace_matrix_constraints_01.cc
tests/numerics/create_laplace_matrix_constraints_02.cc
tests/numerics/create_laplace_matrix_constraints_02b.cc
tests/numerics/create_laplace_matrix_constraints_03.cc
tests/numerics/create_laplace_matrix_constraints_04.cc
tests/numerics/create_mass_matrix_constraints_01.cc
tests/numerics/create_mass_matrix_constraints_02.cc
tests/numerics/create_mass_matrix_constraints_02b.cc
tests/numerics/create_mass_matrix_constraints_03.cc
tests/numerics/create_mass_matrix_constraints_04.cc
tests/numerics/create_point_source.cc
tests/numerics/create_point_source_hp.cc
tests/numerics/data_out.cc
tests/numerics/derivative_approximation.cc
tests/numerics/derivative_approximation_2.cc
tests/numerics/error_estimator.cc
tests/numerics/error_estimator_01.cc
tests/numerics/fe_field.cc
tests/numerics/no_flux_03.cc
tests/numerics/no_flux_04.cc
tests/numerics/no_flux_05.cc
tests/numerics/no_flux_06.cc
tests/numerics/no_flux_07.cc
tests/numerics/no_flux_08.cc
tests/numerics/no_flux_09.cc
tests/numerics/no_flux_hp_03.cc
tests/numerics/no_flux_hp_04.cc
tests/numerics/no_flux_hp_05.cc
tests/numerics/normal_flux_03.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/numerics/project_01.cc
tests/numerics/project_02.cc
tests/numerics/project_boundary_01.cc
tests/numerics/project_bv_curl_conf.cc
tests/numerics/project_bv_curl_conf_02.cc
tests/numerics/project_bv_div_conf.cc
tests/numerics/project_common.h
tests/numerics/project_dgp_01.cc
tests/numerics/project_dgp_02.cc
tests/numerics/project_dgp_03.cc
tests/numerics/project_dgp_04.cc
tests/numerics/project_dgp_05.cc
tests/numerics/project_dgp_monomial_01.cc
tests/numerics/project_dgp_monomial_02.cc
tests/numerics/project_dgp_monomial_03.cc
tests/numerics/project_dgp_monomial_04.cc
tests/numerics/project_dgp_monomial_05.cc
tests/numerics/project_dgq_01.cc
tests/numerics/project_dgq_02.cc
tests/numerics/project_dgq_03.cc
tests/numerics/project_dgq_04.cc
tests/numerics/project_dgq_05.cc
tests/numerics/project_nedelec_01.cc
tests/numerics/project_nedelec_02.cc
tests/numerics/project_nedelec_03.cc
tests/numerics/project_nedelec_04.cc
tests/numerics/project_nedelec_05.cc
tests/numerics/project_q_01.cc
tests/numerics/project_q_02.cc
tests/numerics/project_q_03.cc
tests/numerics/project_q_04.cc
tests/numerics/project_q_05.cc
tests/numerics/project_q_hierarchical_01.cc
tests/numerics/project_q_hierarchical_02.cc
tests/numerics/project_q_hierarchical_03.cc
tests/numerics/project_q_hierarchical_04.cc
tests/numerics/project_q_hierarchical_05.cc
tests/numerics/project_q_system_01.cc
tests/numerics/project_q_system_02.cc
tests/numerics/project_q_system_03.cc
tests/numerics/project_q_system_04.cc
tests/numerics/project_q_system_05.cc
tests/numerics/project_rt_01.cc
tests/numerics/project_rt_02.cc
tests/numerics/project_rt_04.cc
tests/numerics/project_rt_05.cc
tests/numerics/project_to_surface_01.cc
tests/numerics/vectors_boundary_rhs_01.cc
tests/numerics/vectors_boundary_rhs_02.cc
tests/numerics/vectors_boundary_rhs_03.cc
tests/numerics/vectors_point_source_01.cc
tests/numerics/vectors_rhs_01.cc
tests/numerics/vectors_rhs_03.cc
tests/petsc/65.cc
tests/petsc/66.cc
tests/petsc/67.cc
tests/petsc/70.cc
tests/petsc/different_matrix_preconditioner.cc
tests/petsc/full_matrix_07.cc
tests/petsc/parallel_sparse_matrix_01.cc
tests/petsc/slowness_01.cc
tests/petsc/slowness_02.cc
tests/petsc/slowness_03.cc
tests/petsc/slowness_04.cc
tests/petsc/solver_03_precondition_ilu.cc
tests/petsc/vector_equality_3.cc
tests/petsc/vector_print.cc
tests/petsc/vector_wrap_01.cc
tests/quick_tests/mpi.cc
tests/quick_tests/p4est.cc
tests/quick_tests/step-petsc.cc
tests/quick_tests/step-slepc.cc
tests/quick_tests/step.cc
tests/quick_tests/tbb.cc
tests/serialization/parameter_handler.cc
tests/serialization/point.cc
tests/serialization/polynomial.cc
tests/serialization/polynomial_hierarchical.cc
tests/serialization/polynomial_lagrange_equidistant.cc
tests/serialization/polynomial_lagrange_gl.cc
tests/serialization/polynomial_legendre.cc
tests/serialization/polynomial_lobatto.cc
tests/serialization/polynomial_monomial.cc
tests/serialization/quadrature.cc
tests/serialization/quadrature_qanisotropic.cc
tests/serialization/quadrature_qiterated.cc
tests/serialization/sparsity_pattern.cc
tests/serialization/symmetric_tensor.cc
tests/serialization/table_1.cc
tests/serialization/table_2.cc
tests/serialization/table_3.cc
tests/serialization/table_4.cc
tests/serialization/table_5.cc
tests/serialization/table_6.cc
tests/serialization/table_7.cc
tests/serialization/table_handler.cc
tests/serialization/tensor.cc
tests/serialization/tensor_base.cc
tests/serialization/tensor_base_scalar.cc
tests/serialization/test_01.cc
tests/serialization/vector.cc
tests/sharedtria/dof_01.cc
tests/sharedtria/dof_02.cc
tests/sharedtria/dof_03.cc
tests/sharedtria/dof_04.cc
tests/sharedtria/tria_01.cc
tests/sharedtria/tria_02.cc
tests/slepc/00.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/umfpack/umfpack_01.cc
tests/umfpack/umfpack_02.cc
tests/umfpack/umfpack_04.cc
tests/vector_tools/integrate_difference_01.cc

index 0b667217594daf3f863ba679cbddd20e985c3d0e..a5d25a733b2eb473e7f420df37c2a4f9945a9b09 100644 (file)
@@ -1,7 +1,7 @@
 ## ---------------------------------------------------------------------
 ## $Id$
 ##
-## Copyright (C) 2014 by the deal.II authors
+## Copyright (C) 2014 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index be2a39bd87f6d370e0cfc27656faabb3eedff73e..48bed628e602e12f68823656c2bdb5c6f08d6856 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 581a7dd4824653ed05d7e30ee7feee7fa472ce71..f180dbdda0489a6ac51017bc71fd82e9454e8236 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index c6b851f437b3e4fe20dd5b96e86e146f83ad1abd..4261e491abb807bb7d552008b9035d6e80648fd6 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 by the deal.II authors
+## Copyright (C) 2014 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2fc11ae5f9bc5333682c63a4056497e852626823..9a83467cb262ae331c45b07621448ff9cd0907e5 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2014 by the deal.II authors
+## Copyright (C) 2013 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index dd9dc295c5091b30a5ebe7f1a53f205769bc96c5..80eb4f44abd8d6ef3b093a8cc22ca0c518660fba 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a7ac40aa7f71dd601f7a05829ef13c76225d841d..5ac2e6b6593fb84fb40c45680b4bf97240f9c34f 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 059466d7231ee57b8001c409e11d6302a54b51cf..ebf3ef8e8162155eae653740dee5c651c25105ed 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 by the deal.II authors
+## Copyright (C) 2014 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fa8cee79383afda5ac1ed70b5f082483267995d4..e09106c6af8caa42fc9952e0f576800a9ecc01bb 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 by the deal.II authors
+## Copyright (C) 2014 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2f781eb1b848adf5556532dc9f8bf32b4a08ad45..7f1d396d6489b131c1daa8903a10a3381c2342a0 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2015 by the deal.II authors
+## Copyright (C) 2012 - 2016 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7c239f525b47de716617b8e40e3e373eaf69dc8e..17da5f440f9ed74d5cf5dd48d94596f165b0e4ba 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 by the deal.II authors
+## Copyright (C) 2014 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2e224bb298d9de568a77140e15100cec806e035f..d63669dd98a601d1576e6102482e68fc9a90f1dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61c5dd24971049202747571a62abeb724ffb007a..1a5aae3d4d11018c9addc5af0839f37ae07584eb 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 1df5147b5003a5035ecfc6545ce8687672076741..a9494df710fc41c1065db07e9c109aa52f5c96c0 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2015, 2016 by the deal.II Authors
+## Copyright (C) 2015 - 2016 by the deal.II Authors
 ##
 ## This file is part of the deal.II library.
 ##
index 33ec369fa4b60bc2c64a39ef6947ece6facfd1b7..8fb86336a970fc8f3f7df8897265d9ad7d12bf55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4cf836b54ac4380bc0ee7dd2cb2f1bbabe0e0a43..50ea691d44a6556154f873edbd879baac60529b5 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2015 by the deal.II authors
+ * Copyright (C) 2000 - 2016 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6507fdba9dd1e420cffa558d9bbff8fd03b8ad55..cf089844ad26a8f780324fc417aadf512dcf7e70 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2015 by the deal.II authors
+ * Copyright (C) 1999 - 2016 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3181164a2a5a097685225baf269ee38d37c9e3b4..a2e7dd88a342dd2ae849bc586ae7a291f2519ca3 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2015 by the deal.II authors
+ * Copyright (C) 2009 - 2016 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 65add033203bc232070fe1eaadd4af84794c3c5c..e77fad595eb2c0e5c01ab67ee6c9f1e3cc5fe1c2 100644 (file)
@@ -1,7 +1,7 @@
 /* ---------------------------------------------------------------------
  * $Id$
  *
- * Copyright (C) 2009 - 2014 by the deal.II authors
+ * Copyright (C) 2009 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b68fe40446b86df85522efee2fa19abff1685e92..4b5c350ab4b7e74442c568751976467bca665894 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6769cf80dfeb34bde3502192cdb24dc4a2fab68..f70aa0600b3b70edbacbdd90296c948d6be55969 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e7349386d1a572c0f98173aa7c16583eb010be9..9f37c091fe33bdfebd9c17bfa1611574da565201 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7fffedbcdcb4b40d439a6d9a76fe9c6bc098777..99582d8971a6444e8e34a058b77be4f5b2610e8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40646674db4b5a3579cceb3d665750515cd66c08..486d569e1e9531ce8912cde48c239263d9ef50b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2015 by the deal.II authors
+// Copyright (C) 2002 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e03148f7ff2233313389e9b96b67a302b82b2f1..a9946098b43d4cdce76fac164b90017fe7876c6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59f1b0c3303b0a8797e338b6ff30d58efaeebdf8..30605c3cc4e448b1ff2b4b04aa3e68e9a448552a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 577a48fc3e3ac2d109ff52b7e12ed5cbd1ceaa06..38a2e8c0175f1c30d2f9a51148085d98e02e823f 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: tria.h 32739 2014-04-08 16:39:47Z denis.davydov $
 //
-// Copyright (C) 2008 - 2013 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb45c7eff75cc24a5b5e63a5d5df9c7aca22f1a9..4e4184d4e62fe1103ab9c151c6df47cf5982846d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2015 by the deal.II authors
+// Copyright (C) 2008 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60310810a8fe41e425d469dcfdb2e01d7241d1b5..0cb63a97f5c84c3c8cd1769f9a79d282f2ab42e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ecee846066b1191e7bf19d02921bd1b4e7bc579f..e81c65949d6f62eb33bc79d83b295ac082176336 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a290d7780a4a0f0674c2f6a22e888c71e252869..1d26f573f21ccee45b59f2a2bcbdbfb588970495 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae1e3e9a4309eed0002cdf9c8ae377599126a327..8ed1f57e1d27fcbecbf568e700f0e94574830bcd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb00921b29db4124842c9f2eb33745dd31748662..093ee16af21a3761352085d8b52f99874ed40b6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cac013f202dc8e38dfc40a3ae5b281e8640989b1..cc2f87cd740bedab8d978ff4a6e57215150c9f8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8023bd88721470e8cba29494b5f50bb589a7d4c2..cfb136073f7a4acb1a58cc3948ddafa8024bb3e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 362666fc884fe724f6ac3ce3916bdc87ca757971..52166df64cfaa9d1c599d3afe4d9e7baad1a48ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57bbb61e848539add186a92ec40017dbdc14e380..b33e11927e63c0b7c8527435f7f2401edfa7d75f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a42b5f27b6e73a44b81535d5bac41e76dcf71817..94798acc9240d2baf4a7a2540d0336b89f652197 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ddb7af1c28f3e3d7c90ba2d9dfddce20e4c17ec..268c96f378b686b137669ec21c19c223b9ec3c13 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2015 by the deal.II authors
+// Copyright (C) 2001 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 332a05635fe4b6f5d8e9c62f14e31e5f218a21af..4c2ff2dd7083b9079e28c4b07fdd49d7bbbea640 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 406565e5235daf59ec9ec340df22647408e2294e..d243cf37d96ac014eb590d6a138f7d677b47df8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b2e724d903878a9475ad8d3dd39afc69c8eb434..eb75df64d143b0644c7abe44041fb1d9c5df4c87 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2015 by the deal.II authors
+// Copyright (C) 2005 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86a9b400a06183e425f5d6c56f75e1256fa751aa..855ded1476f7d28af43d5598828707a31980d616 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e214da6a10da1b8ae41ed23fee1951260b1703b4..5417d7d2d7adde8c054ee04d1010571c110d58df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2015 by the deal.II authors
+// Copyright (C) 2010 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6803d2ae1f23d8bc1653d4ae3b9e155bb96663c..b6c64fcaea786c5b9a4364516ba1a1241c03607a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2015 by the deal.II authors
+// Copyright (C) 2014 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eb50b540e4d1f9bf5535057cd5852af1a948caa..e88571a4e945e0668f96be606320e25cb7cf6c7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2013 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f23a43bf587b983d71a53561b8740caa116aa4a6..b8ef85797d324742194ef3071f2cf15e550f8a3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba987d3d6ff42e3f658ecfb2cf875a1f652db3f5..156501fb3c5d3e9fac833897b7212ce5703fee3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47c46eaa8ef145e11a4b9109776c6c48663628e2..301a44ff0710ee3176def30aaabad5a0af5aa84a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc5871bc5caf84796693a83d258ba505760600b9..042c1f8f51c423e7bcf55b8d9992b57f6f0713e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2015 by the deal.II authors
+// Copyright (C) 2008 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fb283fb9bdd6cbd5fd44d1251a8670351e20c8c..3b47afa1e42e161e7d98f721b2eadd7199f6d62c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e9e0ff8cb4ebefef0b55f122a8b322be6996d15..6a254214d57b1844d76db5370bfc86c511147d0d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b6a2d63a5b8d71fea31701edf3b6444b86ddc13..42af09ee407a0221355cbf946c3b0cb0470c65b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10577a243bd4e31622d7b747fd83ed0295c0f7e6..ed25ee5660a1ca6d4cfa4f34ca3fbeb7bc9ba26a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 346d04d5b448e288f9c65bf7a7989c0c7ef28148..04e10af897b6e64abc569291365d1ed8cbfb4360 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5316b6e68c33c002f2e48f0e3bc432b09e257af..f5be890b0357f4f53ac1bcc320764850c5d91813 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2015 by the deal.II authors
+// Copyright (C) 2001 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59bb8f241382764b042e8b54a9fba43ce3d39c79..76225e32cbdca2b686819e325371fdad59c1bd19 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8882f109a1d3aeebffa61956bbae414e968a483f..6d2df704a9dc3d81fa4cce8d8323e2cf3bae9bca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b40679b49c80c58ab1def4b9ac466d20bf3837e..eb3f11620f847b17cf8b8f1e7539909cee1ccfaf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4671bb5fa227bb27c761297c1bdf77e601d29daf..f693089c39ad7e6518cd05adee44f43b4737f17f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2015 by the deal.II authors
+// Copyright (C) 2005 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e693263e0e398959be6ef1ffad73d266c7775083..d0360045d8fced68711efbcba11d77a6d3934deb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 284d8deca5d602c55ae538f2a7221eba37425da1..0ca6d65756a38ebdde77fbffdc185cd5a7c05161 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 221bc3d0452eecd665c2371750649db9d04a6877..f41185d0cab8da5e26107ab05bc1cdbc49161a5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5857231920b12537e9c6c328e0437c339bf76edd..664d29ef7978ba823626faddd7a1b92cb4c78fc8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d17236532f8847265beaf93bf1cd47ed7b460876..f2718a00a2175ef345c58d32bb8824535f46ac96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa1426220553780f4b7bf4ea043e15af3ee0d98c..ea52665cab3be4f3230ca84611a675c65b2ac205 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c6c5877202a8ac273e29b356323dd9a1d1b4a23..f967d8c53ebe9fe5f0c4cae9419c54ec765364ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b3872a3e45acea29ea6d190e0aeb62724794c8c..e449912e017e860d0653726215b6da4d0965777b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1700253babeed0773d38aca986981286121ad43..9ee229c6b234c5b382be494ef3287519910ea6f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 627f0c18cb77126402adc29dd0f03cbc4c1a31c2..edc01a96f200942c3d7dc218dfae82c7ff3b8f11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f12666ca2961098446fe364b45ac3d817233d0d3..b52d2055df59ad1539e184b263ee39c138b59a50 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2015 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f6a863a443ae14bee124d1f7a032e9a20c431724..011929824e2c63eb8a24e8fa26ee973bc3f9801c 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: tria.inst.in 32674 2014-03-20 16:57:24Z denis.davydov $
 //
-// Copyright (C) 2010 - 2013 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fdb83f5bcaa688aa1554de546b10952982b2e112..248a52a59090c4edca9b9bf3b175af3d263840d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aefb142022d61031571f3ce2c9ad728140f2925d..8db94c26f95684508dcc14fb1ce5b40c84f62ea7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2015 by the deal.II authors
+// Copyright (C) 2008 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93ac41e8cb86ae0d31357a73bf15d6e6a42fce15..074deeb9ba29b198503e5a69c0fa2878b8aa1d06 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: tria.inst.in 32674 2014-03-20 16:57:24Z denis.davydov $
 //
-// Copyright (C) 2010 - 2013 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76dc40c71bb53cd31f4bee7406b088643420a714..c50e6d2efcac0f8ffb96253a617f1160ebeddb2b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68db7aaa3506aec25a1d52ac024e5f402678f66a..defe7b4c2a50e847bb61e86d74af18201e3ce993 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89b18ca7de186cdb19e8dc6b492b2498323aca4a..feabaa724266607dbd06d7c266f39280922351f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 064c480a2a55ad7b48cdcb7fe979619b5f8daeca..32b7046a426ab8a74d3827ca2e734f041788565c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 559709331c474ba3fd8708652990425969d8a4e3..b51b641ce29a29b96daaae938e4ac00d902eb4c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ddcc3173f7e5d6180e14253af111454bb7ffe046..ae2a2788c9931516ad09116ee4c2b3e77fef026f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcb488a5bf0d3ae5b419df5e3598f2282b955868..d9011e17d0965fd4d6c935a6bdef17a46d56b5e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e36e6bee3ad64ca19feb76c372d3992fa2b5bcc..b67cf87cd8b0947987f05ae54dbb6721e602e62a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 73056608de8152a2bd574a0d5429a2e0acfee2fd..44b7e5fc6ce05b945dcbc910fbefef7527f62d30 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2012 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cf26de8ed9c5fcf7b88946dd7ac521550733a99..afbf2602a995b080b0b695727191c6f7015adbc3 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1998 - 2013 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37a1a297ab6c0d6cdd4f2b4d0d8f26a29eb98369..39b7b1e822a619531605c07d0ae6d8c3b9326f4b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a81f17cf1294bcd4c4292120e3111cf29742630..7a103be2a6151158574a96a64150486c6c4e87d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aefbfa6849bbd548e511c4a4f150d6ebfbd94ead..f2875ead112aac1f9273b7b4f8c92423230fb1a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ec919f04b6481865d0c909b9d06b4e9769cf71f..8c6e7b4d14f5275c18a79bfd5b352e0f614269ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9519d43e7d9508bc55ee98736135c89fb92d67a8..aacdfb8a823b4d61ca54cf68eefe99653dc6326b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f71b70f90c7a4fae3eac2601ace56cd36c42b304..c8c1443d9630819270ab8d66a2784c80fdca9248 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40efc0e120d4e5f76e773171dee1392dc7d04ad8..4a17b02061c34d8daf27ba1de3a6a6f7ca520d5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8034377432d8aabe4451ba07cd7588ce00529152..324b6ea29c918181984c3f7e9facfe7b21bab9b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3d4237ab36808597ccf2bf94c65a03194217bfe..13b2de6aa5f0b4ca1aa27dc4282fd7ba23635bda 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2015 by the deal.II authors
+// Copyright (C) 2001 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b130c31e7da05f5e08adb595fb497db16e790b2b..bd86dfd62b98e8a70dcf63c09f84a0e74a2dd40d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a0c54c3b33d913a8416e0d2457b8b05b5b8cbda..3147a4d5c18bde90f11fc0f9e8b42ef4544980af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee42ec7da5836d0701dca954fdc8638975731ace..e3ed445f87548c4876806bd6119300f8113a9b72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54a3cc3be81d15c75a024d4fc71294b2b00f835e..5d3ba28055f422ad1ab49f50c603fec42d1047f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00e1c6cffa8453612a199c5444cf4aa51b0a29c6..940df00f4460856150000b9ff6b6046258bd1887 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5402820eb20dea896896757096b190dd5ece6e79..77324a3d57d238c070f97ac23fe74c9f5252b468 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19372d48b39d7a525b75acd7101eab9148581329..c12e7f2af337ce3517c31bde14bf12a9ed6ba71b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6495ac4691feaa23c0d0b89198c0c1b037e6cb8..59003b0c40dadaaee67a275cd0c4d39876b728fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae675bbd13e3a445b109450f2562cbf2f22e5958..21f590a2b52952f5cb4681c9026d210bc6f46a51 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44107ffcce8fb5f72a28c626da10eb59797c1f3f..2452756243576da605638f3cb42ffcb3c4fa1060 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8583f7047c140e79e816a402e9300ad25da9bec1..0a96b56317963cb58cca2c63ffad86da6cc7d5d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 014de81d5a8f82b0a21d800def3b61cce11081b5..4a7b11874becd9f4e29906be92decdc01a65a84e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fab36c8459db9eea7aa25110fe9c31399a42421..21622d873abd411b22643929d28227f1f3a02049 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47aeeaa5baaf0b409c8625ab5ded53941c78d003..6e1115a1ae5934a11a1691e482580373c1401172 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f974aba7973cc443d91a70d48a52ea7690f52fa3..2c3a298070aeab27b771e81fe9fd40d14ce2a1b8 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2015 by the deal.II authors
+## Copyright (C) 2012 - 2016 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6c94eb044860775ee32ebf8087cfe11ba86b5719..f2dd74ded2dac5b733190d86a4bfbc24ab2dda07 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d3b8c592b41ae327059b84a9491fbe54ed02b2b..936865af18b3ce2b4a9c4a1c679f097982efda5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8187c87da982aaf80579d1ad9d25803d2c552a72..8e7a292c3e0601543cb2f66c7dd53f172c4c0b37 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25a523b46ad1f99db4bf5c22ef52a22a3cdf28ba..184183d3e8d48b1fb25dcd2210594c0b90e51e12 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d2a5aa1dbc62b885612971ca7854d1325a54a95..9ea075741172ce9093d58dea9a61e476b3d7d6db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad59adc12e429a1d78c709f18547422c4213c64e..7b5da44ab9b8f4b0db09edc470944199d5fdcd77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a77385892e21a24d0813ed5a6be6bec8ccf15cc..ca4562f486db5776464744791b38eeab8ec90132 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e6f97e861b1ac03f55bf6373b8f99329f0308ad..3420168aa76f54e34884f0199429d373f80d1466 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9004235b7a2c750aef4863d00b5c99f08e483fb5..da017a345401304b4de8476ab7027b570723b9f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de2971ea4e29a5d46223e60f1d2f9c828e9bb27e..4ae356561c2931e058e384a79d765cc80448e8bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45745e43656f939b75452e9b9aab5418a07ecd4c..a0c437a523fe6abb90792a7e980724e61840d689 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c23b70e31e3fbbc08bc769cba9a2280862f045e2..2195bd69d38e736665f45aa70b5bcadde2611dc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bfa6b802c8de610ddfe6cff62171c4ac1a11265..30088fd67ebf369bd70152ea8de06bc8fd18f7f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bf668323534dcdbb5bafa63efb7b1afab7a4150..1cecfccd9aeb92cfa19f2ee0263b760503277d64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bd76d1998dab33bf6e8e7703fc58ca04d522d0c..4dec8b9094a4d6570099eb63af9f2d59a7d1c85d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9810ee74086ac8b5271178d2f7b9a1b7898ab60e..2f5359d88f74d04798c381dbddae73acf4f7e16a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7078b979ccd3ba63500295358e649673484762fe..62fa0f8b2d51cce6b15918b3bbeb8978b13b6100 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9075d676099371fd22556f0c1d59247fd6cbd78..3995ad9004cc137ac685a29a462af80a02c03f34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56cab7df270f2f84c37d233442aa1db0d2b6b498..834a2da01307388807203d7002c4bd3b723ac74b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c05fc08828dd045fa8ed485efe43f12650657ee..e17cb7b720178f31080ad5c464b19459524f85cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a05b70fa4e18aa1b989110365d5cf6f58c77ab64..f058acaa036592cbd41b6a5531becffbba86c270 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fe2805802a2de38483a3edb7ec495c437e9352e..6f496987a87553fb4f9b93a049a4f73d47139e99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d550a240a8acdd7e5f0206ec2afff3b9e2e082d..8c1ae0e778529e1d206b86938427a7ab0193f471 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fb76b2d59fe52347eeddbfe531ed12acaa74ccb..ad590c5b07f069c4d5b52fcddd9478218e0999d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc5f08a8f2343be2613d74b3d021b16ea6fec6d3..afd8728fe9f335853f536994932b94c4d8550f3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75eeaacf56e2ba09d2e5c3aab3ca048d2e459deb..3b36ca71387b1f471ec5579e4e0a4c3cf14f037b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bd1ba30aaaf76f8e3b7f3acb3f7a5543a62fec5..5560d5967f058e8ddd3290122ef86aad029f3299 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e779ac4e0d2562c0acfe28005a88ff36e8499ef..a12f187edf08be684657ac983a9be11c9c8bc1b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6459798745d42d6bc65d00dc1659c44589358d9b..bae81f1577d185b4132ae00db10471c8b5a01424 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d16974969edcfa0bbf0743927f7b8825a9ea0d2..28dc2d3ab0c26d3a24a15d0be3f3ce305ec9aba1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fce06b18da43d5a0ca86b952483a24df52bf29d..5f6404ed69d002505293f92a891c2f41e616f8c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f0ff99246882de51bef6cfed53ac8988f75b6b4..eb2869af310da9f9ac525b0edbc7101fdb0685e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf46686fbf51a89ead9c3ef11294935a08aae1ba..95cde3acea936f50c01c5da69633478bb490cfa6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0dd7dfdc593bb40024c4d04e7214d4c475053099..187f1ba91e038f523f4ba516cc1e2de47160d2ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bd2209adb1568db3e009317e980e1ff42d2e177..fc814283cd8aed539b644b01e512519d0df3a5f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5be3417db4f778d0e05c99ba3d091c44e592897..4ea58ce949d730a160cc329a76b1d886f8a26275 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79239decf1a205346e12ffee9f58948afa7099b3..f4770c3337c2244345c4ec43b2f980b9d565ed61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86239dabd39b8122fdf660c465391a7b964438d3..443a36ddcbd4daa96aa7a70591b075afb4ce2a6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3bd93e01b14fb55095d975897782633123fdc25..324c674ca67c23cfbb53f557614b8e312dd9d819 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52e79dd876c7c9b35933a6aebb54233ae6b33f77..7995bced6af687499ce77ece2ced15f46a5dd111 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d817292a2a194b97a70e5d9f5c81d2edadade78e..179a390beae2e473805b3e532245ed71f7e0f407 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57ba539711e72acfc12694df041bdf0dfa17f5bd..fe0c1f76eea4fbd1e2f679bde97b471cf4e7c74a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4fc99446843891534709673fbc1ec3a04a0b098..d103cda19e95e9d788f8d1860a4150d23df07ec2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 904a7953f1257d1364c30cc788ab2fd562baad3c..90263d980741adbc7698832c224682e6f1906b5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c659bfac322c474aac09f4c090b4c3ea1866d9d6..14e1213c930dd88508b0fdb2f1e18b4623d70129 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64fab26f7d41997acaba0879c4bfc76b01b4d13a..6fb237d829bf506b9ea1efd5842daad9b3ba714f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef9924c459bbb24f9750fd8accc64e4007e56136..8260be9a382f2a63e28ce7ef8fcd689f9ef361da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c777f264be46d9dbc989abd0d6770c8924edc47..46d4cef10d1ffccafc87493db5e293fd095aaeef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a122e4f699e4a45f9904990817e78abba608f12b..045c344f26c50edb2b73aeeaf3ad45249c18fab5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c03e424248f7d0256cfd1b83fe4bb9b451d7a872..9344a7de13860b20346f733141d839f24d26e446 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2718bd2c5a0dc72afbcbe351d3f8ea794b05eec2..b8639ace343b518de8f1c12921eba42217c3ebc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca9e1db07b0c3c1c76a49faecbb6936d5023d833..d13553d84ec06de7261e90e7d195bda7ac4b0df9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b019b7ac68e01343a2375fe1b4029b936207c74c..5b4eaff673621e0c71f76686c38b2dbead99671b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c44cd49d1ab9ff3d2d8c9084d3142eb8dd0e009..83e1529f325f3883923253de38dcd31cee78c66f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c86f8f6b7fbf2b1f6eab50c3d328d9f8e3b20838..50d643cea20207bdf5cedbe0b7e3f22350989eee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 678004f80cbe7584f0e6216ec82c0b0d2513e841..2a2e91ac987d94844069a08d18ccef158e4cd7cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 280d5ec0dbbd243a7a98217c815480143d09f58d..80ad06e0511fff98369c88c4c39f5610fe67035d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fdd895488da703aa9920543e78346d47a26546ae..857360cfb7c719bbda041f516565f910ef0a167d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29c95fa41cc2e6c6472f35267615ae9b525b9fed..9c3fd3936253863c87705ae1abbd7416b635455a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 136b6ea5bd2199b63901dcffc9997febb45b11fc..755df3e814c6dc3d73d154e605b01d11a3528fa9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42a3069f74a99e7885547b92e3a17b7680fbebc6..d851d2bc301127e13686c05af2187c5ac8fb5f73 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db8728a7b83d560dac23bd0061feee11e9f1203c..7e44e576c9d3ec3505fb5b2b363e9ddeb3a88aab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef4c28c71c0faf9d403833998def099ec39d763d..7bb56d62617b89d167d228548b7f26503d83cd83 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba216f9387c0d3aea47b3a8b3280dbaa2941c4f9..4f262f70f134727112e47b652395e6276c2a461f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da31e2ecf78074a7e594415af3a84f2f5338c330..56467dc6c5293353016c750cb5f03a2111ce8362 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b007dea28b57200f5cb0daec44c485d5df9acaaa..7fd0b161538ce4db2e127b7be6f561e733b66356 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2ef65fb2f40225d54809b8506d811755a3469a0..1fc8ab10d87c2fa17c7bb910586ab7a815213cc3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef3347b180581c700a8751fcd321010ce16ecf8c..65f9170ec3075502dd0b3211d5db3745dcfbccf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5fd517f36865844fa2d26c4a5792728098f4364..1a1e227690dd156b30b0f286447d9dc3a16bf578 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b202e513c1ab0d602f84f48a291f28338f1fa72..7e57df6107e7a16570e0f102d3d022efcf884b17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e362c8a13ae0218f644638fa6cbf6fdafe717028..33e9c3d492bba07a24a65619ab7b22fd46f22dd8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e09e3015d3a063b08ce3230915edc7670ae273d8..d78be9d6feb3fbf2423c99bb406ea3ab8144cd15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 346471d9ece9fb470af5347c70e5a4b9d375e3a5..0bd848893a6c28ccc18a6aa4ea507b6a5cb2c8db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9b66178ed936566a3f38134db11d09cb9313ba3..ef3eae20eefdf69b9d9daa41a65ec8ee5ce92c0d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06a9343b0faa5750c3ef9f1a2cc9bf371113e6f5..4dee18406eb2824342329b8d9f9caaf0ad56712f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9530cdc5bb2e524a5a8137e46b7ddc75f6415d69..9734a8733564c3c2610f9dd598104133318e411b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 424bd2b6f80177e3b531a3f6574f1100bcf32e96..adf99f44d689855cc72a7cea11a631c4b2323e4a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8510b2487fb423d3781787120ac515c2862e4d2f..cfc378b7f8b42742229f80267a51a416b8cb3f43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bf11d3ce50bf4024fa76d5f19bf1f59e5bd4388..0f756ce498dba8f77f8026ad737b1f6472bd36e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acf7379fcad4c28f0708d7d38c478d1a7ba06a36..51b09b65c7781ef16d8f04c5950d81b92679a88e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dde0ee1e7f0ed0742996f907cedb1829c7b7ef1..056f43d03a5af4293d25549ac1951fce11d3ba94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 351e1eb7271dc9045429b0a3d4e5a86996c1f9a8..b4dad222dc82c50a3b7d448fd9ad00a6814a8481 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a14e8623623f824f6f198f0cd9cca2ed57b037e..599e9893b7e81335ce39649db79a0042fdc4c59c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 321d7a2f4d7af9d89b8d8a5142228ff5ef4c02cd..c800f92334908dff743acafe2000258a15a6ed26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09488e8f964546de11470ad3f891c37b525288c5..4fbdf186aeb695ee106a62677486946bfa182c3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ccab5189db2101ad77987b9fe9bd061afa6e7ff..bc97f6bcae618017d0ca2ae1f7c27905c7cbf176 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d033a41e3cbec5e48426e6936893c7085da366e4..c3c06f68ba8ceec3a1632775ba84110fd132eb36 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a7db07e23dc12ee3ae094efaf23ef6c20825d15..5301e014b6a07c0aac180f193a11684c1320eff4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32eb12bd314d00f76da6356e1fe8d0af93210530..1668eb0d444b056d5494e9c81516b48aff60daea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c1957bc1038526ae77671406f7017bcc7c241653..e6513e497d17e3cbad518618c0897a1336bb0e8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a5337b449843b0078106bd4a55fba0d8ddea9c2..2ffa7d6ba94c2de297109027026b3f98e86ff38b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a3ad6f3caa22a07cd995b7d5c1fb59528cb3d6a..47d975bf1e2a94b96f7e7355e5fd6d74da557206 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a555848268daee8a133c7eab8ed4ebf6767e7293..7935120c273920508d9dba513720ba53701c0a4d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 468b660471b074ee9111587fb3e7fe7e9cc79240..7ce6fd730a457f075c201d609548396645728475 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebd2d4d7d4d1347242dadc6b7e03d5c90ef9a1d5..8f19773151ab765d14c85c196a2d3bc37efa3d99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b89b7287f681fe1007b7da516b55d66e877ae45d..fa2525976f1052189c4939ad00cd1e5a5540f900 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0c065d34b531d39a243671146d097de3784095c..11e623f50c04042454e8c063b86b898a547cda59 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2829f85136b495268fca316ca945058e2ba86c3e..94e355bc86a40421fc91f738c8d33dc4ed07530c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f54730e9bda59f57da4835e12bc7a9f83e5e88a..1afbbd6e8b850f2375db4826a416c9b37d1226c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2816bbae3ea817d894c7495325639e5f4defd43a..0554ec0a83356540a981fd6db7a2132162b9c9ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad80d8243095899eaf3fc24e413e6b73a2c4e1d2..088a1cbcee3613bfd052077f5c492edc7c105741 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56b5765bdaacc74782244e81b5c20a20e042bc51..da6b0b9c2279db47afa220a620707b5ac1bf2448 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed0fe5208fb2b1bd82a560d41fc7ad15dbb62ce4..8f9b93f0a950711ad0d14e6f07d83ba10adc3128 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81cb8fc9c6c000b549682547498eba4633ea3acc..44ab0151066d2eae5e453532b2c08a07fc5239e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97148f6215557fe4a39dafee554254413b32a87a..d10ff7d70b83fb71bb11001d6dd4708cecbc313c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f499991e4860dc8cbe0a639424548747ead57bce..7460169bd7e8bc872df95865eb10de8a27d3d425 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97fce12f808a423116d8b19b3c432ca1801fca78..868e8c3ada148fcd2be41c40c46f301479de8eb7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c890cdb7a752dcadb7869a1d8bd4fcf3cdea2213..38834185eb5a3ae5bf7e8bb7cc37c06aac26bd22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 15bce51280396961f31859b8e2c21405ebef9ed7..cd660ec4eaff8978c7b020c921445aa0a8ed8df8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdb5702a74655856d518c1dd6cb28bd7f9712546..af1127cd21f5b76bce899b5e5e093dbc137a0392 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5215d49c3b60d418ff5645fb63afb3a9a868df80..24674778c307a5e8d71b4a649a1faa8b73a498dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 959bc63d0466bbb1650b273c98268259526a2ab3..57f75169a3317f675427808895c6dc99812b00e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dafa581e3bda2ee3855417ce5f9085f66c81d70..de74245df02f15de3548c51c0f803147bf782d17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40f3f2e38acde3edfed59c1115d6159615b538dc..a2b94d11d0597ea16f977f006c605b70302c8aff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f63b4341176599be5f694aed1b10dd817ab273c..c9685e36f97c8131321eb9433546194ace3f7e37 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0903a34bb825e57f1eee99a8413b2434e1201a7f..612e38e383a0c7dd6a9bba6fbf0de1f7441109ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 440fb51077188656cf16adf3e11aa9d7d852e52d..82c90339deb9bb7ec4c55aaafc96009d5ff0d1d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd7f5c15ac9ca55ce7337bd262df076194f0d55e..f1f157bb055d8794bec1918e8a70faebe0052afb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ed18b1965eefe407f78c93399456efd098eded2..eebd3e92281097791ba8e12f4be58b0be1ff17f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90110887a8a429d65859905d01b8a068de75c49d..36528bd21ba7e41d882c4854f8fdb25e863d01b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b9221c1c33d4c09078885c6808548e4e5409bb7..6841923fae11001726f4150fb44d835d3dc3f38e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd010a8d8ee147f601d4081b2b93384551c7c55b..d5e81a424344e05d14623fa4393b8527ca5aab7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc15985bc0cf12d30d8c4ac1f79d42ec96bdd0a9..bd9a94775f821524088cccd1fc8d04d07b05fa45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b1407adec3fbd76a50e1b0fd05bc13d0f871bce..e58b1d3fbf3f791c15ce25e5e811571da6eb896b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 411b0b93c33a6fac41f7d03237982f49231a8b67..c684317774a17b9442a0e1d2ca8515078dfe3800 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bd22097d3af14a36fbdef29f45e5bc733dd65e8..c4d143227071d13c8bd6dceb4cb23edba5b71168 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a572bb0a590b30a24099a5e9cde8e6602e59b9d..9e147bbb0b60defab397cdc6e8cdb03461cd6d09 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d871bec01d91d1a5e356cc77f25dbedb06511728..89837b39d07d600a24469f756fe1654952982aca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fd818a6af5aa396ee7074a577f3deceb0ba16ef..d60e929ff039d84076e65f86710083d6829eb9e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a2eaa45174bf672da9faff5fd6c7ad8d57b964a..f9a93338521410e20949f8781c8e5f8f803bc63a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8611dab9ebd47b0736ca18d8494a2dbd38cca60c..d90f6866f465e35bae60d32fa85ec5a8cdbd9a74 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0356955526c3a52568bcaf4fbd54b72d2eea2d38..10bd66f5501c190a036ff73aef4433bf533ee9c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2594791325323e36ec731831b9136a8e98730214..08679d676c16fa66db0b3bad0e11eaa60de9a08b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e2b20cd2f3b7ffe783747c7e5d80bd489746fb5..618ea567d8a0f4e6780be2c6872c0aeaaf011ad0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 602fd50a3e7490ed7ad1f1aa3a3591e9315d8647..448b7c2f585044b8b46de798978f7fc763478066 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 286b8891b861c79b8d444891166eddc794e1f07f..01df0b6efa308e3eeb803974c622e6b444193be2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55a004adfe28e0866523e4c5fb9b3dbadfb2a167..f5587638154e07b508630c45f213c29b7836343e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93d5584a540fadc83d1d23492f4e21c85871cf7a..37eb672084149e3352f89a0a1b040c4c245ba6b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8cfa44af62f0ad275cc341f970a5e241cb5f656..0f2e23ce434b8e85a4b1c857540d5cdd5dd1837a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b585cd7715a20cd453423c8007c02f211922266c..b2b6974f28d725a2dd7a1cb960e40467e8cab072 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2bf3da1ad6a181dc90a23face39f59e1a6518a3..48effb18610d311848d35f0dbccd86ffdf1eee1a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44d66a666a23b1f606c99db49120aa39bac25c3c..f71b6a1c642e2f1dc910091297ad62440ffc27ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a4338ec4c896da52dbfc0685b8c2c442c72d599..f8958378b5a35d2cbdda0e6d338137051e2457bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 805115c826935b2ca06f36d41412686327972749..304686c593dbd364df1774ab8cb5a2db94e2e072 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63cf9a03db6504696a2465755e7cd35299cf9551..70fcdd706a3854f053043f1ba33c095092377b26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a4e19c9b6cbc306fdb00b2de6e4b591e80806d8..683e1649212adf2eeb0bfbe7c5f5fc72b26b53b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 999f5f3dc209e10365eb4e8a8b9f9caa91ae4487..6dc603df54537b26a7c0b6f4f3a8d20c159a7ee7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1150fa54296e35a986364d69df0f039dba08baa1..39b9703f178c541a18a834a0b802fac07cc9cc5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28faa95c0a54ef4e57c751a546ccc032398a5faf..8901612f012a51441dd172f0588f4d8dce7a28fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 662394921d7de317612813cbff383cd5a1fc8490..7581aec84e5de6be1ab09fab4eddc5598166259c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a82721417ea51d325dfbcca0fb28a369f1e8c109..51cfe874655f6bce9ee9f2db3b7697f1fda0c8ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d218a2384a7f49de5db7ce472b9f92a6eae65af..1e696cfa91cc3af40679e2b67a37763e7b07e031 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45630d1c3af3639bc610c7452e47fe18abc84cfd..e36f4dc62edede1df22a16944f7d1b9a7c6a27ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d785092fa6ebedf4e9207d1cff185e90f0bc130..11f329d95bffdcf865c4d85ab649490ccf4d6410 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef6017d53f07fbc2731ee6495d2905601fcdefda..96e4d14c2c76571747c4624e58b00a993805e315 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8a9de57be6b42af471fba15e6f6dc976d62c34d..873949615f6fe4e3ae75cf431b5d89fb9ef1b60f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8162fd15791eaaf72d03799bf2d67738cbe2b442..a7da8894f9ace49f07bed0407f4eadc7921f5aad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed3725a841017100c13ba5c6a788a2f1a943b919..01283f43dfd58b0519dce1be00cf3d403518fdcf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b24955cd2b8ac366601f57d6dfcc31d567154a54..e169725efa55ec0178e9e222f94c4db147051503 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8d26dc87cd6ef9f066f8ca562d338a81931b63f..3e485b58dad3572a0508c46f8b51d690c00e2562 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7882d922bfc04e3b165eee2f134e52bbf3b1de01..f1f2e7e262aaac83bd81c1a98eca5de0ab824354 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfbc1cb6753c0d6cb1b5823f0aa44aadadb03b8a..f099c4f190e8f33c0e0a6b5fd17b0ad79f500496 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2baa68cc4b77e3b009eeeea029ccf2d5a5b1b5a8..34c92a02ad65684199138aee2a88634854595d71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 613eb3cff613dd47e92465c9eaa1c60557aa0a2c..24f9a048778132f1abb12de76f15ead5d9f6e9aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7de6dcbb932b19e993e261c599d1c0367154bca0..5274ba241d604a3a0ee06e94155fe17f3fd34aaf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a637a328ca69e22e647cd64ea7c7ffca92a2030..0e47d46ccba245a74926529cc660556608b9ed5c 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2014 by the deal.II authors
+ * Copyright (C) 2000 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bc6c59269d04f28cb8dc487446f5b47715da58da..959809b3279c51b1a4e258d846b044325a7b79a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c453ccb2c36fd2dd095b5b3aa8febe3e1143b71a..222dcf64a7688f572e8a1606de79bd0780c084c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7838abf2ec45daf71547711b305a3c3e48bb5e3..964dc7a6e2853ee5310aab7c6ef2502acbefb134 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77421f433ff27b7d51f9260d21e2f49613076b76..4f39babf506a47f4ba0b1d335d2c50b7d8633f8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b46f119c4d1ff6e9329fff23d43c7beae7d5b00..dedf5fb43ecd0871644df62ce443974c83e07905 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 891657db65d4bdafb4bd1df810e11ab52caac191..7bcc8a146989e35abd312c44eec5cfe3a90d572d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3179f199f5d4f00049342b2cb3bda8eedea6dc02..4ffd659623f362489665fdd3609f40788d0774cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0414115c13af612ae515c4dd4737b7f9ffa0626e..57957c8e2292c0e609ae7a71b47ea4f1f9731f4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28b5cfe1b23683a8fcfb4447d70132bc4965736f..513b10edfbf3e48e8e38a8359716a1b4bf64529a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d82724e8374d9b6472b490b4bea22c03e06c1ba..c0ecef61565447a01e18f1c7bdf4bfb53ddaa827 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40ed958c813b34ae46692644c5f16d458bb1864e..d315961ea85e13b8bb06c3db6defc74a03766a7e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 311f43cb2f2f6da2254e3a5316dfe4240ce5c769..c70f44b2c83509aa4aaefbad04cdead9a9c691b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c968becd1307c2452b93169086af48fd397b683..5420ad0d96e5be40a006ef636261a5bcb8aaf2a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0463045bad312e592ccff75c5b60f567231c3f51..d5ec2d1b78fa125fbe5978f717bfe471ffe15e98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ba03703e30e27ad882e8582a8b4155f54064af4..87ad1e081b1dbee94b6af30f7bfc7a5f2220fdbc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6990e596e689959fae7eb30c5babe6beba4e6c1c..b47c4ccd890a03431831d8a56e216df932e869ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c64aeb6011442a981b81de1c75b4c49e31ef410..773844e4c9e89915032e0e375b737d2cec87f6ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a23f3f45b2e8f306076bf7eeb87fab680aba8dc0..9a5cb3488a578158b7b7343c78b827bed6e1d6ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 559663e4f4ab0c0476846af9bacdb36202303053..06e34607d9408c53dffdab078b3e1024c20bfdd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0dc747a8e257455408f9f48455fa6bf5ee0e7245..7daa70400d4b63cf831f52cd7218e5ab0a3c39df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9729ef7419301ac39475da905da965c5cc76717c..ea13e2d93869e5b330d5451800e959f400d25ff5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6849b9310bab64d9812c85dfc660a672d5b7103..c042851225fcf82f9564ebff38d890a8a86046ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5009712f29acf33e2df4e1e2d5c09fbaffef305..3c161ac15ae3553bbea610317ae7b08366a8e49c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6513ea9afb8af4564412ef0a50b0126087d7b1e..90b37584fb0b7f29866ae163885a414e5c614615 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91a46f5f5b8de65cd190dc990429d63d23590caf..408ac798fe17b4621aac920aaf6389f026b41eee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4274ec09bdedfec250d3575326142a256e4ec585..0e6f67d1395f4621debe11044929e939357aea2e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9b3c70b58953b4ac813be7065f49b34db4f10dd..705e01fa1433da6636ca09a4e83f6f63211e7186 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ce308331a2c7a28fe7d650407a4fb2edaa47695..64a394857ae68f406df92584ae52c62a4d1d9416 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1edfe1a83413ec6b80fe4d1a1c0729781c2dc6ae..45868d008b7e45d9eabc6a45d621a534ca2cd037 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1979ab6456201bc890d18f26382a55237153f868..a9ec10e8afb8b0fe0473600dcca403cf3b796a73 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b92a7ba8bba4a355d30ba49ec8f097c2f9f287b6..4823393147d9ebf7413ebc2ea9f6bba34d9bccdc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 152a6a8f44b88ffa72d044e945df8db4b4272d11..39feae2270fafa26db74e254c77a482f097bed9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa32d392608f16a2f7e5416a19de8b90e9bd9ae9..8c04a9db9cc924fcaa34e0d579ab3824598180f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f55795184587264b4add1e54a8ac83f06a3cfc60..4063825d0fcd297b944cd691c954f9dce94f7c65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99685a05a652748539b9348dedf8496d6d0966fa..d8834511af1264020b7b0b62e7ee5d8ba3a6f249 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a8b5b495fea634678e204ba31d7d16f1516eb1f..921763dfc407acc6a839ded5c2828d57a39f0bb2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5a3366fedc7cfe9beeeb15c7a36ddf4fe5abff5..0ce954dbf362bc03da7d625df784083c26e34402 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c67202022be876a908613c616054c7e6e837157f..5fb12a8c589f800e5f618ce800a74de1f88c71c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 077a695433969d26cbf4390b8bfdd3b1e207f830..3e20d8b6e8bc12fd53dc6ba8adb51d075e4c8086 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0a4d55ab3d75f04e2631f850e964b9a76978719..810769a1190816c3d5be9f8287cc248e11e4a1a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a69402b1f4916403d527d0aef9616e965a0cc8dd..fad7858753aaf3923339bad02b749a7cec0c606b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7fa340769acfbfd0bfed74ef25eaeb59c98de003..ef0f67a0c2c1ace7ec364705d811e4bca9668b60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3df0527289a896f31fd44df227749803a5d4dfb9..1fe4674d206f50afb01744c8cac059e6cec59159 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3935e65f2b77ef11ce736b507b366dc3caddf4b8..38e6a475d4c2da0cb8a971c398b18d9a3f64633d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7447e21fcee3a30650e7cba0ad79fb5f2cbf0b3a..2cc2491eba824fbe0b1a9b8938a3ea054fcfdb63 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eed590559d378f1eefc27ee1d2825a854253e86f..1f8e57518df2a4aa405b0c19199a772f3b7c5362 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6aeaf8e1257e1aa2de725d5734e94bdb1cba3aa5..f8f66974991fde7b8d44f1609c057bfb9fca58af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e044a7617c2f7c6d2593ce5b0b5d49627dccfe2..d4a88ebbfddab5b483f205131fa5a7f1cb36ec4e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f5aad388e970dc485999b0ee0d9d717f94c8541..dcfd5ae41921108aa715134852998a08512292f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 933ac3ed42fb3eb5a0cae29b7de2d0d9f4f1d872..f8b92062b84571d2d4575ce93066e27f2a64cba0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47bdc9067ef87968c39df8484bf096d60b5d5bcc..21dae6c8eaad325969cca19ede3e84e466b87e7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ec2512d648e49b532c2399def43102ba5ab231a..cc27932d1c65fd6daa3de3c3a8e3d1a13f2f0bb3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7faaf9fbeb09af7ea0338ca7673381043bedcc04..27be640fc8965c9b588d0f85d0472e926679cc9e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38fbbb9ac66f79998708292282b800398ae338ba..6ce197c5743efa3722541b340ae66c764b187c32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2007553c5c4cc9a6b37fa405d25ac00fec835b9a..fc6fcf105f4f212398d38779dccdf1ce1ace9a38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 900ff9817429b6a7d1f4614f82005334f3e331e8..1545675e4a31b4a087fb086678003493d1211614 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d27ba4c1e011613f27a62cddbe88d3a8c7ef23e..42161f5501afcb23e849b9c7a44bf2cb1dc7df8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3321216a6d07e90ed0cff4573f52fe0a79a4b0e8..218fc3d2ee24dc87286cb15734a190bd70cbfa38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca5e406e15326b51279f5c76f7fe29ccee116aaf..3e342b6ff57ad774141e550122728dd5c5c55d28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29a3e907eae46c6f25fbfd29154e523320348dbd..35b4390cb679adaf3a566fcd82d390c4b407bc04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3559591d7b4dd6b87a553f3eab1641372990484e..e4ad02916139307591643bffb7d9c0e856f58e69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c800aab61c37bc37584f8693d33f6f30da400f5..776edf1a368e686e08631f407b5016aed1894682 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d51fa893bbfaeeaecc6dfe2535c2a275d228ca4c..353b78155b255c7335da23b158063dacc44a1863 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96003c4e0c705ac7ac58ca31c466f1302ba4ff76..e187db7a822a4b0042c074c1e4f0c89d4c268a15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b411a4252136ae6cd48f918677b3ee56b3787781..9c6926813a0feb5848e46b0f755ff58e20777482 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c1fd5a32dedf30a60a92b088c49a3fb7fefeb9c..4f0c72a72d01dd5679af43d3464cf2d89098a39b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6282ab1c9cd4a7dbf49ec9f84e1d227cb6c42bd4..69bfba36cfbfac68ca793e4e741007cfd53b5783 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92706d78f94377ec0f62c129270587f8da852c85..c0eb65afcb8e15026ccbf126e1f07302665c6774 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b70ca501bd7d9f1a62275c9160b02eaf7e326a88..fe8aa76ec272c4763d4b317a34127b1d852d6ec7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d415f32134cc9469b551be88b46730a99e7005c4..151a554bd5f7399fb545ed8c7a1188a6abeaeca7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31b329be01456e97428420c10a36f0d27d4f3938..d1c8dc8d918fcd961eabde36ac07b908a98987da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0b4d67130c155dc5643be293d254af84cf4f619..4289e5820476e5f8670b644ac6f2b84a6e9cfcce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39fe99269d4a89bbb6bef5b975acd1c80173c187..fd0b274c1c50366cc7519474ca5654a5a34b5ea4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6428234e2333e759d66cebea3550d8498d01e4ca..0da00095bfc1aa51c0e3c7288f150f4b16760a49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1d121f26f3c6ce094a882f37cc07d39778dfaa4..c75d23ddcdf1ee251e68e1b09ab2baa98a44167c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b93efb878453ba773c40e7890a254dcaf97e15b..115aae54e1a4641d44fe1d6366335b71d09dd79e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 551559eca64271f2982ba16b180634fb80be0b1f..f4a8f7f3c8bfd55623eb1373a9357da7a376172f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47e8635383beedd6f777474f11ee34b24f79704d..cebd164bd76c465fe1070b62e95f01bd5ea062b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c19e26fb07084daa2c9102813b6c4a77b7bb129..1bb772085119fc092e5c9648cca244f5826a0824 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57e36e998b7ce23c2a1ce240695d569f6486b763..8e797bae471748ef43300ddb7bd2bf56d686095e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e349945dcd3a79552dbcf08648d45a3dc8fad1e..fcd8829b372b7465045da9a27de0f4f118746c8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index caaf4d55a28276a0ea76417670870bb1eb0f6c3e..740ea627f5cc844a191fcd116beeb7f6846188f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8f394e9c3769c9fb1846ba2cf046fdd7b4d7b1f..084ddc63df21ee8845cf91f7a1c0f2eb4d655d32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1335dcc7d58a24d0f3622608d4b0a0d1d864108b..156efea8d5d6bb73a3b320e68cc574021dac5203 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f393c05ed0ab0024b6d04d3c39a1d5ad55cb4637..72aaa697746939000c2470c78de39aab4a8ce2b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00c0327261a5544910255bb77b291a1e0e963fc6..86ba0c98cb8b6a7f4fba2ea0bb2b8d43f59500b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f65849e5df27b686d50a5e81ce634e3de209bab..6f88b392cd71ffa9cc39e6c1294c8045d3cf1a3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b34dfbf7057854c8906d6cd6601539023b82443..5a3f0ed5de53de2108a956542794c2a5f2e8d555 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f71f53709fa0d76f9708ceb4f706d4caf1645daa..4fac5271278e06581799d41ecd7b83f7ac55fab2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b24718b29904e19955833262ca44430f7769408..e7762eb0c48c95a49a5227ef4dc1489fd9040f8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 534d1a9dc2521165e52831c13459edf392810052..9f66a9ed6a51fda478964ac3b961530010736b4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6a74a4fa037727b61e109a00ff38b6dad392bbc..144e7cd43e10aed3157e40bfe1bf9b2e48f4db4e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79649f124b272789ea22266bfac80ffee9a44057..28aad124bf297eed2c724d7bd10e535fbd34ab57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f537a56ca797b94e3f3d1c14c064639846008770..cdf4d17b611fae791d6a1cf68b709fab5ea27b2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf7c5bbb231040ca56ac72b9aa54475a64214e33..1fb6cc1b022af193d7dff7c6f33e9b296d4b726a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8917927621a3875454aa70f6857f06bb07907dc8..2a640a60646a8eb9b6897c57639fc7977ad3295b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57c1f74b279050e072a162deae44d82920d1542b..8964f059647abd35bd9efb87acfc1e893d275011 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6ae685cbb0b85cbc1004a749bd8edaef6e2e70e..829a8d0bd20dd9342e31f7eff3efa7a8637a5a70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 081c0e76f3e43764a850dc40c111c67332961cc1..1b377772cfd638ed763aab32cdc2e61dd2527e95 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58876f4e097dd76318080d248f10490b693c192c..449cdc2a7abb3f9dbbd123bc78dff807709d893b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 507cd9b4346e6dc32cdea26f726f8503f945551d..203b4718c2769476ca23c9fe4b7e9a890af3f4c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4a21e3caf4e22340e1d88456367b6afc0293bef..f53d2a1ebd6f3dea18b6e3c03988884052ec403c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b59c2a0e6c99bb807ec937a4ed68312a214afe5..63a9d0311ead23b4744a9188f62e8859212efd46 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f94554ae3b109e238256847a888f68f1d7303ff..f99d45f8b4b94cf23599dc9b83248c72e6827eb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bb0e9ed2856588ea6154f9eb2ddfea2e66ce17b..32dff762009cb51bac2bbc89a368c2c4ffefce6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69a40a777c546c43e57859447bf258c89e4ffc7c..a693b57f2350989909a584511f3216bc71f08208 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0762c6c090e6fb0b9cf5d1a1236dec2c8185280..106dff6709dccabb871c6c98c0a0f6d0c3ba8634 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0762c6c090e6fb0b9cf5d1a1236dec2c8185280..106dff6709dccabb871c6c98c0a0f6d0c3ba8634 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 343e6f74b27e8eb50453a633baf00f16b63cf1f8..a9944602380123030c0965f56ae4e56e1720ef70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b3cbb599236f271fca151dd8afa420ae98964ff..67fcbb1f56ca761301586cee7d65516b29e24b26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47affef79d83179890d076aff29ec5839f48b06a..a1be9ad3f35dd49354b6aaeeb82662b83372e3ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 546afbbaacb811038fbe48618778cbf559af7ab9..73adb36eb55d0dd5e210d0a2e6840d45687aecf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cebb924afc8d02b4010d716e48c0d10074ce8d7..c0e07ac0e4e852b3b022920f4218eedd0e95528a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99515f3080c3b03572a0d46f956bce430c2dcc27..5533af15fb0bc52096ba7dae115ac0856afe4ba3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1318c8ad410d4d8bc8dd9cf0f1104d74f9340d1b..a5936ac75b63dfe47b3b9433ff88009a19df5e5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3546c301bbbfe423f975355cda6bed88a2fde388..ffd2724d2af45d072c7b44d34523bd994bc63a7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc5b199e61a9ae21daed3bdb24bb6fd2a019ea4c..6eeff2da77047fe0b52080f4d16f80e39e334ae0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bc9a8606c2e8905f9b69ff9db9173ea5b2d14db..9ac77b19f2941bd2d22240738ebd316bba606c73 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffd9d97c1b0f37ebc204c963303c4725bc5a3992..601e3f800695c6a1d577f10dfcc8649f62c6e3a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f54ba2772f3367ddecc4968192dc8904731eb629..f2b661927411b3324622301a56be489288aa03a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b49dcae5c075e10bc030cd9553a7fdd70fa263ab..6ee1b17ec8327ceef00324752e0eecc1e5e963a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd0c970e61924d8e354de7a0b8af0e6d3e7904c3..1ba626579d7efc2c10fcc1b23a29f0d654ee0b7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5caab0ced24278f699a3aec53e75534ecca64b05..e302b0dd68ef3459c4b4f6f2ba13f3ec638e2e70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79e31b24914a9516ae9a8e71f9f9c0031aa3996d..c62fd8763db6efcdab09f74c34da78afa4de33a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5061bf34232fbd2e8be3f4fa16a6d4612d9e4dbf..17b75b6e018bb95898bbfde50f049d5ea4e967aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71c3deaa80710b43249b18179b97fa69d899f599..c57ff7b2db6a70250a27e9a93a6f1fc345239b23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fb530e9beea68b2910a32ddd84a5cf6732b8ff4..6025c8c1446555ecdfe078be71816fcfbe1ca59e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 651bb27ec2aee843a682dd96623aee8f869c755c..362966701ed0075f6f803411a9564345ec2873bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 931741e714590d4171e9ebe674382cccfa65af13..5f681b80f263f4dcfa79bf474fc42fcc37f4b5a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 213e88a2e904b2d654d4f66bfec2ff0f5a344a8d..8e41769fb720e93a6e406843f7caaa77ba203807 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90a2f2ef1b239f5277a75e2020dc9063defeefaf..7bb4e95583c688336e92f0316344b19079fe4fa0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a101cd2cf28365877efbfca0d0e5d8b27b65afb3..3c68eee04aaa0d64953b4d74ce4e5e3e8918273b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe7faaf79090d9b545b7f09dfd7c962f8751d0a9..b3ab29b51dbdae38708ff7e910b90430c2180423 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c1373d23eea292bbb4a72353065f73fe0977930..e6816a7c12c0ed913e8c73bb5a5b6e57303fe810 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82a6991a7497add9e70af1c75f61326d3f60a230..615651254b459aabe103d813711b118f063d85e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18d274f3072afa4cb53b68aadf41f68994ae75eb..fcb3f2399f5e9eddbd68360c7da8d448907579bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99fff37c6d9fdef3129af865bfade551e3c0ec3c..5459fbe8dfaa8013beaa00e89bf6e90152061cf1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 068a54d8d223c941b2eac107a9d188ec56409416..e56a39ef4fd67126feff4f72652114b8afaec571 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa35541bda1c09813ae74b1398024a3addbd997f..506d12ac79613062ea9897910ae2e73d514768e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc43c23e1ff85e70eb0c7a81eeb804955f4af66e..4d11c9f5b97b4d343388322d3949fdb7253e5191 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05e90ccb2b7909f254cfcad12fd6b6e72b2929ea..40a71e1c02aa4b6e3a3a640750868be1454bac94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5e76441f0c37c92fc8530cf2ae6e573071990f9..7fd4d59f4f1e216a03c2cf063db327d0024d0a49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45ec29fe3ddf2567496ea98c04540fb568d2852a..c38cedac409182340ac7f9cb03919f1ecde42d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f88ba7c3af201fd22857800c607856968ab6cbad..f9b51792e32523e4348d6daf0936f06b2968cfaf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a28373d036d7fc4ebc5c3f47a90e1f8b10840f9..bf2b734f33572230042bf77ddd3fe66d99ae52da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc9663a0677b5fd296a425cc68077f5275790043..e345a013197f654cd77bb7185ab45a83efd8478e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10e7266c73d834ebc6af503ea5cf2d5b81e5be74..6305a665e40dcda7c94585c46e12966a79458b34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f3b9d999993185aea6d66c6cb4dd0eaaa253d19..80a5383b686755e75364d14e098b76403efbe72b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01e6522cb377babe30b1317c8511f6e17e2c752d..b7301e28d9c0f559de154015a76f9127d4f5296c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2166337907a9172f0f8972b0312f652e8d13a7b1..34f0038348f14b040874bdf64cd568c8a977d5e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 850993150cead0188940559893cadf324f045ea7..86a1fb86d8b69a411b9e18fed6c0ab237ab3cac2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 271bd303d12c504a33872e13200fd86bff07b8a3..df100f41370caed7755458f4b017b0a8dee9bdc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 881ef1138698e9f03c6524023f5cebb574467899..a6e83dd7eb630091c19df0c5af0ee55cd728009d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4c6477af4d63f02c881269ecd9dc4a3c93d9401..8f71ae36d1fc301ffa4253c03390f541f9994fc8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e18716550d7b1706189b2b2b0e28540867fbc03..4d6e7bba13804bd64e42420863db19e1cc76f166 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dea178bf81210aae085bf8297fe44760af46ae4..4d3b7ed3f5b47305ebe170dd488e7adde7ea9b60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 621eeb15643f450414f3f007af54ec52d64d16a6..90bffd56604fbf5a5e3b601ce0c48c72151dc68f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97f40712923daf64fad6c06c8694640c361e6289..77e9ee040643e90d40d5b27b8c9b6ff37fa3af1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef2dd561e3c6479242ca09dc0589fab59c2396ad..4c6e704fe1cae0d3b2756f07b08744c0b3be73fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da8fe09b5ef12078d4cc42ef7dff259d3100d82c..76ec371430a58e6626a2ec3115cf218c0698500f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6cdfcbb5c0edb0892e010c21ca0642b829538f1..0ee9afdaad259d4aa9d687baec3001ae30ccf1dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3c7cca95a8d49fc1fcc1e83ece423ea97f3cbfc..8e7278e64a52281cb2d77a0a8d5f7a3dae306f8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f91adb6f42fb3a8c70b99f7e05253763c4ffd8c..e637c51db294cd5725138794bc302e4fdeb62882 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e54da3500adbbaa2bbb0f6ef771a9b8c9c1b5a5c..7363445915f0cc08bf42313a92654930c3cd1eda 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 798933f6155bd43e81746caeee6234bdea11d577..96747136cd9dc0daf537c149f780015ccc256f1f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1961b9e55e9dbcf4cded509bb8e8c902a678fc59..f481aec0e96ab7f5f620a02c9e8f06b068b0906e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e0bbf5b697e0315cc1aa87b610e1c5e72e3d60c..a3069c1eee7d7e427e56311a9c3e223dca63eabf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96a190d9e5c787f13d8be145e00fa908378febcd..066d769dada18854ccee95f194ffafe632219a94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35c3b7edc9ae52eda154727403fed7fd0c4c0821..fc996e2115da6f6bd9c0395f06a59a476c918567 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47f6731ea481a62852d8b11ab9e36c32a9f7179f..d9005280eaa86e10dbcaed7e62baf653dbaa0259 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19b1a579af18e4a779e4027b4c908ef825f6d186..9f56a1733735a4c597d31433c296ab8f1883212a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b650c226cfe281845acefd9a49480e25a41e38ab..32ec9ccca5711a728c6989e561f91ea84428322e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45e26211e4d6298a97c5bc2294cde8b0ee2c3892..b927ffcbfdf8f938a5c81b1931ada3beed62e5a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16b294c9ab1f972c1ed2a9fd2d064c6e7081e99d..2e170640306297d634669acaf517cc2fc9076402 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbc4b05f439740cdb071e3542b1cbafd9c7bbdfb..1b56b842b91b272ef380cd35cd0725efbe39d333 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b21feefa05cc2a6a3d2b4a4106a8def70383a15..1378bdb9946ae67369fb211d07c9995fa18dca21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e15cf35574d78b4b932a68f74a3a8c515103465..63e4e24bc57f7d5cf1306b0f10feb61bf42c397a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae2ab31b687093248dbf22a64695da09057ef4d2..f0da1d71f516a71f26191f8a4a6277f24b43df3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 969237ece9ac25e76af05222d0135ecd66623246..d0ca16434bf165183360304eb9d7bf3042f28f64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9594c2744e65b3238f95aecf2cfcf88b8d643421..bd9c3db8fe55cef5486cf0ba9b7494dfc4471a9e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a4e3b6d823bb3e674fc7dfaa13620c24d59d161..ea6e84d40da9333469528f0bce4f102aa1c64e30 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21fa6fffba22c7c07d09f5ab01b2f17896c2693e..934752627952318e567995e1a7bc724892794157 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 410e95ddfb8d4613830419fbc61bdd3b839b470f..1f792afd721b21e453496a9bbdbe309c36b3c5ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4cab224d5c883cfbe4b07c6df804737a3f8613d..5e11ee7a46421bc27eab4c9e8a1941aa946e28d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 622cf0109731d9bd6c24dd73a63319f36ba62730..ba6e0493d72a1216802ebaa6e3c1b9287916e2e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55b2280c353c97964905f789e3dc956cbf99a711..26c4deac7618a75516788b5ab552879e3c529558 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a93264f7fb9830bf5e67cc39f544005feb77036..ae82bae2a6b851a9c829e860e99d328b9af1be23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d1a3c51381505495a0e9d87724fb6f2288eba7f..e483a4edc0579b293c8fb126455bb748ddc27528 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab36c938a66ad2dac35e2549d02574efb6000f97..317c4d82115d2a550ae92c04e3f4b30eeb657099 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63565dbb66c174f6f16ae9269add8e7ef8affd6c..e7e947a8d581f207e2a51ce608760421ebb24426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43e674b12c965dab701dce21466363e5fe462c73..00cec799f54d4cd0a9b3dcd655b76b5e56999df6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c618756937caa89462ded5e8a243d2a080d020aa..3775b6b70d9ed587974e307a9a13aab761fadd0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cad206ea93bc7fcea7ae2781cc5ae3c747560940..999241cffee7ff4703f93f511a14cc1359b811a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b76a8b57248a64d2d87a75c7271258b6af6274d0..528dbafe7dd6559fa55f1171ed2a26fc86262b99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b90b5c8ae4b35a5d6bbf894841e671c33d63cd4..eae6afa92883b7ff5f4e4e898ab6fbbf2a70d9d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ad27de8626a74603698c63647d3b84d9617dd93..190c5c8b11e7b5cfc4b837260ba732cd4c231d71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05ad5d81ddbe097ceb2e27846f8ad4b485a5d35a..f2ac867804928657091833f5d5fcdd422903abb1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23df3a753f734d3de90d8c31447875db7ae156bb..052fd6d381b8403be20d88ee6ceed0829d6d2fd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60701e38c5982f653998f2296c3e45d8dfebbe4a..6c10cc0d479cb0e31c64eb097cb0ccca74e18f97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bb766ac2d5d38b53d8beeeca77292048885c8dc..ffd80c3ae7f05af36115d6064647dae940ba3c72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68ede773140ac16362bc5637bdc61643df14e913..2e79c7f12e4792fed05f198939d4d8b9e69e3aec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14a951a01c5ca10e3b0a1a8ec6fb953f9058928a..53ffcfd7fc8a924480598ee11a732d165525b0f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54a3a8d0987b317a8d8fae8719d2d08c7e26c9a8..bbff4dcc11594b6d933f2e40fa86923959f29f92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90037b8c2ec65834c7a0f1757bd8d223df64b44a..0df9665a5852298d539b98a8f5868ed26eae2767 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3500b5d6e06ac0f9cd6ada8499c5f4033883384e..517cbd22fbf41e7ac70b5f6ae7371172acee5330 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16b2a27273a6532453a5d997ec23ef9344cf89cd..260cd6c1f21a91085df3a39a3309d93b200c0d20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc56f065be31233094e88319df0d1bdd69eb70d4..d834ade8768dbe1266a2ab509e7b459acb6c3635 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02e972c62a442f6d9fa9f54c0d2faf936aab68f1..f80c6ad1989becdbc911c52a80e77d0bcc639838 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9a9afab325d04c94d651a8472abab4225069efe..6a7aea8c76e79b90d7f0708a22e26a04fc02cce1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e3fa890aacc72656409691b755e38c27adadc06..e2898cb955a645056d45f6b9e2e38eb203fc2780 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c15e41619277e614b1efc75e2bcdae3a5b270da..445df4e72711d7d8f06f08fc8ee81a9902213a1c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f94366b57b92d0535589e3924090995a714e99c1..d046b343694faf6cf1e9dbd2aaee4b1a213ade8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 739d096a8f1e56591b215b2d9c022ef3e8b943f5..c528cb3dc1a827e3297632faf9827d4de7cccb50 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ddaa35939373c714676d14f84fa11a40479e0eac..f66e30095cf5f683dd12e9474b811436389b6374 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 917c76f68dd849a1d03b752758323da8faea2c1e..df014749aeab1636e74a5a6bc5de39da553d44fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2c985ed45ab78bdd788d9635b42a9d5867f6a70..35411b6560b4c25af1b5e8a39105b7c8ec0f2ce7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1248e68439899b0bdfd7765444af126cbc08332..92b9956c80e11b32457ab7818283cb928cfead14 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d481b7b4b0bcdb160a7321c55dc63e5dc4802d5..e26bc11668260d39a543879f230dda618f7f6c23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0400d09959678b1ae5d877d8baaa225087c476e2..598f102988bfa1db788223d7ac0530d8eee7046c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 232bee16d88d3e0fa9c4c6592a6d460e3e846f62..4b1a2a9ab0df99d595f57eedcd87dcd40f2d283e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe092b672aee0eb11119acbfdb95e82ac39352a7..d64b717141bbb915ab21d2561c26296ec9a0f595 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc59d5e38fcc4bb584ccdbb86d52430f84919183..6b611ebb542a6241101cbad6711b971ce91181bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93730f213d6a09f4e1a03d34863cb7f262d59719..bd7ab10556eb702edecfa1e0690e7e58a5834ecc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be0f207694c9d5920573732943d84e7a229f85f6..0d3261f03d0f8fbbf13345b16c38713e6114d8b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b9584aafd5e467fe47102962768bff9720a61ec..97663f3e03f3917a715f037ec7902553d291a8ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0d82b7235012b0e4c9f104327360d1162d68e75..df3925840fc23ec027e3c84a0ea05cec59b8472f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab65299b7aeba17b6d9c02b6f25736ce7f1f7411..037ba07143960d7d1e0939bf2ee83856effbc7aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ceb2c91df3d9fadf33c0413f10cc57b85c836424..7d7a14354e213d697a07aabcf3e110b87116ba8b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 162d676f39b56c87b0a2239da593ef70466e3b3b..a7c4dbf400eb33b452df8fb14cff6a1a1d8143bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4a0bb0fb05e896c7f4fb9512482a9f8e50d21e0..6f7eaaacf7ecf9c37ed55d8f1414c67f8b8b5dfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92240934244a3f6989ef0bea12729388b68ca041..1a1623f42a9adb0da795cb302475620dcfb3648e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c37e32bc8c37784cbb9430be790571f8cd5e84ce..ac944806daa587697a9d3f25b4f5079dfb07e8d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 340bfd4da6c9d55d4267878f7172b34624963902..5b63cf50deea889d71980f8e9337a4c0c4a462cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84a166201691f3e7257694dea034b4904176561f..221ccfccf026454026bb8419226cce9ebaaa62fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe2ed50c51b4afbe8b37a8d7f8dc00430af5786d..ef20bc00851d77e63f1509f761842fa4cbf5179b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28404a88db12352d5fea1dd8d1c975c40e4a95dd..da7122157865989c9d605962bf6bfdae853c1d9e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 037e213d15330155a941eac6873bdf34f0346b82..7a804ebd9e5e67f3b0331abc8a6846e5fd026d3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2745234bd5dd85420b3058f0c2596860c079276c..dae8645ac6323a0b75ca1223149668fb62e0aa8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca9b60abd3e846d23e2612a136385bf6b8e60580..a5a6a964370ad7bc8e2c75afb1415f33f41e3a2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b98116265794785aed4f737936ac9368587df65..74d809616edb4ea5d11e0f408970f2effa4ee3c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3429b240a334840a7883a035c16d9d744d88a46a..4d8e27a3461e4649856a354963bc5a825a923e87 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03684a1a9da091d4e5dd0e48b47e3d55930af909..0760e2fddac55251edbb2fdc6d71728864dd34c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d383f51b4c8aa1d4c0072df523a2ea51715e1e70..4c0bb38e840ea2b4b560dc52f213b01da8c13972 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index add268cb48f270fcc4ca8ac209f968778c45eed8..6854082e02da9a161cc2250d8d538c5d7688b7d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7d97f94a51886caf78ca51cc7da4b95ea1b4bbb..8446fbebe598b522fcef62b7532fc09d9a5302e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c07ee27353042e43a050e1308e256f18c04b5e0f..5605ccaffedab1959a342ab73da901e63f1e9d2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42bfc831fe2f65588cf433e7b36667e411f5c67b..e8a71c0ceb3a8a7ad6c48745a3391e24b5f312aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86f11c9854e04919ac207300f838f103cdf6baac..4796af99f653dd53814551e4d808079f09072283 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49b0457ea4439e3962acf8cef48e5120473e1fae..fcb46a01031305161f9042c82aa94feb5e0b0778 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13a97f5f03c331e74d77cc19d04a1d32a2fb3fbf..3d8ba9f6ca0da662530e815e823dd4f890ffd8a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1097c915ef4e2109b1a1471b469fe313a1245230..0e29bee7fa57d9ad7bda201f8f1cf6347b5495b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e4491d8baa099ba946715244f2305623212ff16..cfe0c40c26739766d6575ca7f2353e1062863cc4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc5b17a994d96c02edc386467b46cf3f3779b539..f62d676dd2779a73f40b3219615afe5a1f001777 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 146a0c04a609d1716a7ae72f90c41ac12bad1b1c..55fd3f0927f853cf493889667d365f5adbe580b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8a4763a58b38019ce76a416d55ecf9ee1bdbcc9..0097d64935e660919e2e4cb8b595cc705667a86e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51aeacd76d47292269cb0049f719736495ccca6b..e11394d247714ba90388fc4ffbe63505fd34199d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be8f27258094a7373df9b765b569d4d6b60d2483..787050484aa1eebb98f5972d5518f97acf1aea4a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dddcc7d1babd1710a3066d30d9f07272c7416817..2a60489e2b2e4e4f29e04366e25e7c939174c05c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 558e7416e829b8e68d269b64c187a6fd7e0ef28f..c512b8885b4c0f38e1e9731033acb6aebdab80ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b84fb3694d000018f29c2f68859d40da9385e28..a4158fce7bd0d469b8555e825f6e2f65673f6754 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c0807858659c98b44773055a071e750c88f0816..1814b03053b7e0bb0434e491e4b2134355653831 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d73b2fd2d2e79281c522c9096e01cd8ec1927a5..8e4129e4f7548144f1e4a75050220617ebabd6dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48399cc7eeaf178e3eaf4c9e17ea118538e2ae43..dd285e9e655aad7f201febe31f172c013f1b4780 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fe0dcfbf62833c387b57f2c676cd7beadd88626..1eb4d58176ebbdd25969779990070a34ff1753c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5408e6732f25f904d745071d77413dfdeb9b1188..077660fa542f7ac7129fa155631b3c2f63a38113 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf96de758929ffecd3783ba0b6eb8310b0d1bb7e..7a38a390ffbf530d8558d6a71e776fe645a0af0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f79059a0ecb0bb723846ff8dfc95d0c8a67918ec..3e5956b818e57d607463d568346e76de2a1db70d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3504450066a3ac2a65fdbdf40a929ce98794441e..8f8addfc18fca2294a44749deb69b8856946d467 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 832996c73830d05200cdb148d90f91a6afbe730d..7041b6af4ebdaed7fb6db9a2c7e277b143880306 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2ab4f7c552e7f94e9ca60f1445d8ca9809bfa2b..5c5374cbb65a7dcef6994eb908c6f53a5c436d93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbbe2946c68f9c9fd4d95be8e11c84b44258cf7d..e8cef9d69152ac464dae532c16821244d15a136e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88796f0c89e6fb4d1635b04ef9e37a38f4ad2056..8162d69bb1196d6d6b2a4f7be77655ddc8e38f7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fe07fcf6b0a3c360cc96ef815e803d4803580a7..a4c8cb3a31345e287c94af9634cb6e08398d33e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3c1646025e038f0c32b41fffcc07d364682e7ba..0dbf5fcf14962bafc3742e92605f159beb9eba99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6acd51a358bbe463246adc5f400fe41a579d4c09..254bc0718a387ba874fc010351ffb8c804eec268 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8dba4a27b2f58f3b6bd25274514f0ce97ddc54bf..17a3b888dbccf5bdbff2af3f9550deb3acabe70f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40563254e088325c22c3b0cda40596f57d94e11e..6fcde8ed19af592d301395f637a3e683e9aa2777 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 815bf3732e0c907c5206f85d4a561941c4f3706f..e94d7f9e6dafa55c2dff4d986e367d45e41a16f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afe742455422f35cc95ec29245a5542c2ff00d05..a16bc0330259924e6b198e6201ab58328317c884 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 033cf1f163f8c86d3f1f9f74c38cf2ee9304372d..cd22f7b4e6e4338d959180c7504b69dc3473473a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0135f98e9570a731c1e16617ed29c43b7ca386b..d5898d71683e02c82ba155e02f2f8ec426fe4822 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a72f18ad1a44bcff4cdfcd138274991d4ed68e91..7a70aeeeeedbeb62a785410c530537ea55a56ab0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8e7d4eaf42fe175685cb0fd75ec98604be5a70c..62ff646f26df67accce30aeb04430191806320bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8a19a59aa2494f96e1f5fd15763ef84d6871633..eb130bc01d22306d69e812cf5f789cb9d133b3ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb5a4ef25ee7e1604c9a10e3609aa639528406f7..71f9d9c25b6c1c43b18a06a923be1a48de07fda8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82d52ee522dd1c6c848c3d08179a5f74501db511..89d68fe2fcede89fb8b4109b72274db428a4ff23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27364363813ee7fb032537e60f9bf5b9320609a6..3c70cbb2fe44a955997b9416133181217425dc8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8797175f8598e6b86ca4eee86f3aeab494dae22e..69b6a52c5d5edffa8b5e177c96dc6a31d8f94621 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a512befe4905d6a88133e9b8a2a40036df46772..6d234123453a315a5ff6538fc43dccfa8a5385df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 804a2ffee6885bd227eb48831cfffab946174414..df5032476d75637e647fea9ddc5f69b3e380a4e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fd6eaf964e1cf8ffb06455b2cba5a6bee21787c..3ac5414cd74ecde97d702de2e790206038a2f81b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b6191166911ed8b0784c88f6675b7e73f835615..3fb19d95b41c7354d8c70a8d772906e291e93268 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84bbde99d9cc62b0e876bb9cc5e81271cf1c9edf..ec6b2a138118f9ef4e03a4672819d88c9b310fa1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7084f64601b27673434230bcd893d00b9b42a548..3015f6db4057ebf2a3941dc840c6c73322e8dbd7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03c0959139793ba31f0d284ad19533214c842319..def4ee4992b6cf95347f17ad140d76ba15f5082a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1562bd2b7dfed1a2fe69458cdf68b9826e349f66..3beff049086800e0966e6f0a1968f80956b359b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 605006f8e559bf648ca0299f90d2fdb84b0e5737..75165dd1b6b0dcaabc50c221c8fc56643c6e7431 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37f137ded1a0d26d3916cbc9a21925c7b0770807..24d8d81a1184532c416b3ea2aa49e3ba5db7cf0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c083cec30086de138ddc78abb19992e6dfd72f7d..48ec887525b0060c34553d1842864f16e8a3b426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f9c20c044b81ca2dee18d7b7ab9bc21e7032491..a328e16110d7290d746c6ea78ccc15a4ff6fc7b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35f6ef1195571fd2a8dad96ef158eb1b526a804c..8888fadbe2eb52d7cabaa09a3ccd59b87fdf694e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f42e0867c8307aa60b065506deb8185014479f05..1353a1e2c4621f7bf3fe15963d08134049b627ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f97b22b3b8b745ce1c5a073093e7cb0328dfe9c..64fa4ba900f5ea497c6ffe0045609d02ad25a1e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fcb0f2ef4215895e4c6ae8ba20a64291869f6cd..21c5c4b010edf81c7fedd70c0e98c11238920246 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc1e6612c9b53c2f6e6dad376e40e2730df27e4c..a169d771a863c47dfef0eb0010df771bfa31792b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 884ea583ff270f01277e373cf4744f6934ffe2c0..bf23acd719970db93124e002bb67d2cea9cff401 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfb4e4d98d5e8081873a02ad85b18b7bc3936f17..0c16f45324410adbbe4f725a0e2088fcc45bfc2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4feb138347e04f4b21693044a47574a119dcf4f4..df522d3d44a2c1e40a2ac1dd474e31bcd6bfa75e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1942871d399094ded7af65ccf94e0fb77a60e55b..99a3ce1fd4d9af91f37e8128075594034ebe83e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ae8a4dfae4ee9b0d0dc291f4d8027358a4b2106..5663696e1bb8f8af6f1a9b9ea77ec165953edaa4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e998e602a0f9c0fd715788efc30e8565b3d905ff..7aaa457ce823b2dced4cb0c27d27d2b5e6080565 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c6290a9c96e262439d05388bc7b1ed8c811eadc..6961e0387d30db9bcfcb715dba84684e8a36aeae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96f54d0c40f3ed710c80bd188e0605d8ff80d38a..c0b7efe74076ffb9af9fa97b97bdd8587d01092a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b23ac24264417cda7761ce897e9a87c245d459ad..a6998e420a5efb425af0a84c27e08a28586fdd55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abf17f6bf75aa0ccef4cfbbbd68f0f722116eb21..7e0af4d3e9d0e3ed876ae5a8d0da48efdbfa135d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75d628188e033a04ce4276037e44ee5b7561b3ca..213f33d20faad26dea2cf504fbbfa47e8e86a69c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a873fcd17a696fb7271be8d6b2bda8387d8249d..548362e84a179ea843e3fe047d63c576084385f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee807da4cc4f62346a8d0430c5871807a7dd27f5..5b4288dcd66446b2bd389c005b76068bb7fdac77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b3b026587fcd829e2bf97847b06b9983b96a17e..0838df646721b9c079703992bb3a8f3b771e43cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 348bda3e6ee269b5698717668161388112367119..73e7e3ae7d5cd27f79783b3313fdea2516cd1be1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4f45b00be27f651c41cc008f3d33691f52d7f2c..54e2b50ccacbbf155129cb915efe3ef666779936 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7728cb4566993dde71fe4932e9ac833e783efcf3..27f8e95a9475e8d1212a2ad2d8cb80b84768e40e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88bd1b51cb1bb8e3b5fdf8dd5a5d52786a9f709f..779a9de6e88c5eec06e52187167098e7132c715e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b820216371b64d7779e3a06b3c978ab6381d868..87efb526d4430aa9ba0715e9167aabac0c57b829 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 873a51bc432f7739ad66148b603b13605ee0e303..9dd63fbf2523fcc0b3386e74fd400c008f4c9c83 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa27ed5af88e922234a23a471305ccc36c6e2edf..ea514fbdf288895ff2a5fb9d51fe118e735abb9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c1d3e4c9ba7ff0c0c8429b3bb723c82c89e7cf0..e4e8f08487bb1ff82bd635f44c227eff8e088660 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c950ccba62c6a6073b466390db3b5d07041cc2d..2dd476d422819f17a9cd3b041f1e2469fd56112b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52f5a9dcca2527ec690e985dbde06d49413adfb4..8d9fbcec9827a076ffdb8168a8c659dbea2800e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 660d1377c9a59d3f009d5b1b8f1f83065d41265a..4ec6626876801c6091664e283f3c05ceff06d9d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a59baf3ed890d9b1e5db2ad4b11156ed3438cae..71b78b088977486df259e7e7db9e97fdb7065dff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54e7ad498cb1df82e19940fb88ce9e5fb0673194..1d155f131eed747c965155e7b83640ba6f27b9a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e268723476ab7cd72047de74da188d513fe4fea..6a06bdcf8688e38fb9942afa168385ffe28d8cab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 475116443ce9366ec91e164dc5e93db09b855018..9030d56636632b761d70ecfe5af948c4aed27bc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 599611358ea853395f83f334a4bd50dd587a65bb..1f39f5b91ac1b8970793f39c7b51bbe989070126 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c482f035075e6d820a72f2d12919523c489b2bf3..ce5348978c33d1efc14c4be698e204f25707f3a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da0376021dc871e3b59055a06c8e920aa49ce75b..850525812ee7e61fd06f18ee8cf7d4f46c92406f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 574ec12a5dadb022d47b9782589493bde6dd1caa..921b6f8d0c4a9ec774b7ffb4914eef8bb8a854b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3799ec92b1ba1591e81593d3340d331447ddcaf..57ea37813080c9b087f5b59fb3352a10f4375192 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eddab4fd454660ee6c1b670b06e2ee5b7faf542f..d604665ab19a55049bd51c26c6823e7f7e26fbf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cf440f88ff778e936288cea425a85072bad806a..10d231b7bd930050808f29b0ad6935d1fd41ad39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e5c73c9ac70e9f480abc2f5945f805eb2cbb6ed..ba42cd8bb597a1090dd8fbf79ee0a98edd2f7866 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38c7d7ffed58d2c89c95f9c8796c238883a33e59..884990e5bc3a37ba705af9492e1c3ea0bd0c5cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38c7d7ffed58d2c89c95f9c8796c238883a33e59..884990e5bc3a37ba705af9492e1c3ea0bd0c5cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 123d114bda1abe6d8d0667b9de829ba8053a4f7e..8d8ca59ec66515f86d3af2aa5f0579b845883d5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 189b53f639d0311a37be5bb5fd9e9b4deaf7b801..989ba3f27e2923628df99bb0e567f4349fbaa726 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6247e975be854159133fe1957a815af631da845f..5393468027f1f9b8f37101b2d51d04c919cf8e19 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7c87db066664472851dc1700316b6f530f2b0c6..8e7890f1ddf6e68f60efe87aae38d70d53222533 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17ea39024b58c79c108e4668f6d2871a7ee000c0..52ec1785532cbd88455ef12eb98c9a81d8a7d544 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f18d20ddfacde8eaf7d37d0632b3f8e936994364..de855032e387a4c466eb3d7404b3b7b54665b949 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce7c50b84f9defb174e638f9c62750a6fdf70414..56c4131e45022b7b8d6b883ba7f35121bed12daf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ac3ca9e46557a7de61248633cf78e1107e882c6..980d09ffa0a52b31205ff5a86977e7385ed68a00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 832b366ff7eebbce2af0aec9fa710eba6423a246..28888a7bcc5b5530ec2bf4bbe31b1e58fab65ecf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8a604599deedf160464285a15e6f9defa6168aa..8b0e9cd68eba7dda1c8936e776ea6a5205917ab5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0626c730d9c36dab2eb3ce8d883e2f018e6ba5d..61404a8cdf3b98663282cd4f8de8c6e5814d9ebe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bd2f869f19ecaf33844be3e40b30a3eb6224d29..dfda72329e396b12a88b3431705af79885f4a5da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ef3ebd3fa437e057121feb2ee7b6deabb7d1753..4125a27d20c107bc31aa68e71a4ad25061ce2c3f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 589b0ddcd0b546947c11e6c0726bfed7d2d5a2b3..d56d0fc9985f84f177bbece6b800dcd8402a3b8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7d092396762117e497bb8f0c09125e3ef06e04c..3d37c7205573b9c296839bfcc6bc4c87007008f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4bad7c4d880b15f047e638efaa488a096ad7188..280dcd2fb48982f30b87d25371ae6937dc69e240 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97e0a3f50ecda3ce87c5e59ac23cc4599ec83622..ee50b6db10b211c0e982c02e8af8f6b4db21d050 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0253972f2e354e238516d98c09955cd07715585c..b1f287a4466fd86fca4941ad842399525079953e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0627e607eec4362e60a6ffbfbd90b97d92800cba..fa015db3768ca565ea958d6c865384ae48fa02bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5903daa2b0be8da9bb55568032e1f9ef429df330..943220a7c86fddf47c37a212675d51d6d97ba856 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81cb67d37fc1a2632e69cf5dc431b09478915d42..5631c573976ba046f7d3dbaf628ddd346eb07883 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0b38b469aeb665562b015bfdc610188b6be5083..f2b2c3cc36092c5bcb996121210ea4754d1644cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a62adc1c5610267f2423fd876d3ed7057c29ad1..6ed68c23f74165de3da484b3253156d713cdeaa0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2925e5ba915e4fcfba7fe03b7e182bf161aa94f..311fe373909ad43695c900ca55e4c90bbef2877c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 562a8dc221245fc3fe99e7faacf7c6775ee4fd70..0247a065ef439dcd12bbb438f6fe8853bc10ecc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e3acf58a0609c6f87b7753eaaaf2bb6f459b68c..7b4bae5e102033388a7c3af08b3a061efaaaac5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8509109699a708230bd61ca06b049144345871f0..49c2524857555bf9250f9d65eb075fc95ff40d1e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8b92956ffe26e746b9d2b75b4c4d0e8ecc19313..beca814c5823808980978429ae8e5985bfc47b5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3f2eb20c699efae113b64ab18963215fc2d84c6..2e475618a7221076f529adb76f521603b4b0f696 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4cd77ef1528d71be83c04bcf81afdc5b85c30748..5f961d8d5edd4501364f960568eddc2a480955b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 408a61167c291bedae1de7b9e68164c3a16beefd..5dbd9f7d837a0a380c02a74ac7b3bb039bc506c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf219ab0edcfb1532370347d2b93b9b68e8ed472..3c19972211ab1ab16770faab19f3c5eddc6264dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 349deb89fbe90e8007d2a9658e56a556889749cc..c1738a0fb3108d3565d3199dedb1b8ae7b2260e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57f781efb928cb1d5d4ec22a952dea7a495ec514..98db0658855bc2e7db848ae56219ab13054dfddd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd03f077a059fdc5c1cbdbc14e1161a6e903bb4a..08139c4168f8af47ad9ec2a50eceea9d60956ecb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18d00fd9b6e95d266543b1d29db2ff966ebea062..874cf518c4fd13b9abb3e4ad51da974af38294ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a869f4e683329e1eb9585dc1429b2da245c0168f..11d36764addb9ac56cdeb4ff9dd767915545e927 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84466ce93d77fcf07adc14a1425aa061a5ced117..c649efc5d20d169b17f54b5e863b720c7318ec05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9dd0d7707bdbfd18687d0a4f77637a247143adbc..e282f64debe14f353a777956b32a42a1dbde0ee0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f82a4fcf182d963f96313bccf5c396f9d7bf2079..6e2a3ba2e7b6b287bd80758f63251df4033ac981 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fbe660e983bd3f1e40c63de3b416b5f865fa796..05bde971ca30b6cd32dc3166e31d0ac2b47eec3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c0a5ce14089abf0d874dac0deeca1cfc9abbbae..2b1d50db01d02777fc6279a7f56e2d213afc1806 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee67f0a6a35f8688ad112ba3c56b0ee045e79b75..f07bb57f9d9692f1b9fc6f84da65db9d81530ae0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8f70b7231a50fc795896d45b8a027264c902ca..b86c0977c3f5996d882467e15126d9af9609f37c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b17030573aa09a1b48dbf965cb552180c8416cb1..1da2c9e3c2a7737c8fcc887333159c310d1b3741 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c400dd3cfaf38d374649987cfeeb54cf18a033d..3c93f2d32b97fefeb992ac032bb08ed4b614cf97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cc6d2c5655d8373b54382542b6f21e9f7b518ef..aa1131f5364f932b6f75e5f6780a47f12f261b91 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cb908f88d8baafdd7e8ca3194bcb4f96e9ceca8..f4a06a2a0b1be9ce562f5a7b00af10cb7493ec78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04c86850eca6d6203fa8b5ec8130ebceb3ba490c..fc21a1707037c0f042bddffd622cd08d4db1c8da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f6ff46cf873356a2fd6a3e394309556c71bacfb..4ea08d2152c7c4eb53d3d53cc058d3cedb7c0486 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 815057d8f6eaec1917aa82b1631547c2229b45d1..d8206978eede60c46e453c5f88da4d8b246ad15d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fa98b02e7dcbf17f0fbf83b95fda6792783a2ba..05787588d668e73557e09ff01943fc9cd7308691 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bbe21c5e98b0571fa995ac6c176f28d9cbe8cb5..adf4700077f384ad30c46d34c3ac09f69324326c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffe978b252d1981c8337ac733a6b912cf4456ba1..2804cb3b5037057bfee94aecd1f1d515ee4ce1c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0132fde60507a694c1c42abb74c4ce9afec20d5c..3b99bcdc00cc093d01d73dc340ebce9f36ff3849 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb3c7c5b0999efd1c4e05b3b5a2d6083181cb93e..7e6404f547ce6a1165dac913ffbea7716022d260 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6294c15c7309fe901ed5f19fb46953f27197f7b1..9b0c5795a76d70b9024cede3dc14714caa5af2bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61f8f17cc394a835c9e46c2677ab9260cf534977..4db1f8162a885f62a27d9a7bf451a01c8a3927f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa3bf132e00898e49b3237c91db407b88306522f..c02d0c166433225712554826ad16ef6fde886c5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5546f2a909f61b351b7080fe910b54b8104c597..55ab2947387963c3b70c79ca2dbfbdbe04130307 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93943b8242282a9de014902c030403568fdb2a07..180d981c3e582feb5b417b72dce526888f8fbf49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b867ef6d10d0bd71443dec1995fab53b9fb62e36..0d18a731537b03c8433cb2b83c3310a3427ec501 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b006e1cdb7d22f9965b1e1ab7aef64060721bf40..3590b1417bb1f1bb17fdaf26cbb283e2eaf442b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc534fff7d384cfb484879dca7ff331d58f23a68..83ec52cf58a7bf71703bcdfddffc48a63b5eb62f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30321c9e6678c24b66043ba29fdda861d6e5bb60..3a235490d7fcd1f7f2f134cfe74381ead092f475 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e90f896384eb1d31dbc7b3b1b90642464b97a21..46a493b4e20307a2135899d511074da7165c1cd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07b5c367a981d19d2e0b8d77795c57dd85a0012f..d87a196c83a87798a5103de8d2c99f27f42c2640 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea85614ea3f0d25c3c9da2541cbf5b88b3e9d1af..ccbed140e83d80ec8a09dfcfb31ec658fe9bde39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9c461618a81c1de265f437e6590afb96b1cf14b..99c595e5225a26b6bc954040ae331e33b1403bca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb528d1eafe1114d77416ffa0b07331796116012..e5dadf1a889fe27a36577ad2d93f48816381746a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ddcfe276db903a2e6a99522576beedb2897079e..fa1baaead73ed292fdf28a46beec034c16e48b04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aea07bc9c555fabd2b763f541ef4ebff7fbd2b38..573db614516ccd15d3500d964386f0f5c8f7d56f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7956d94b1865b958fd4b3ca931ca349d576654cf..108b65789d190c17b4fea9a5bba92e846d7c05d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 806e4ec08b2d754fe4dd446f7ad3a081fb626152..c2c7827380229e85dfcb3ad892f6437e8779bbe0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16732886a07ecbfebbd44f25349f64c8d2416d9e..0878065bac8548e22f5f11ab127c6254e2a5284a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa2df72f50495971e0de66286bf002f9fd76b7bc..91486370b0cceb660d05a519dd9894f8a004f67b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a01bec260d2f1234bb7728578e23d9178d03b2ed..ef21e7521534e925ca18e0f81b4ce14f84edbeaf 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2007 - 2013 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bd10db2f275bd044ad1b32b35c61bf58800bbd0..36ca49142dba4b2f0475d01e6c2a03ad02f08c0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ab2c217e2faacf907e9321a72e8afe8d5f5c0be..7c89b748f9de6114ffbf4261594627e2aa60df55 100644 (file)
@@ -1,7 +1,7 @@
 /* ---------------------------------------------------------------------
  * $Id$
  *
- * Copyright (C) 1999 - 2013 by the deal.II authors
+ * Copyright (C) 1999 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 07c9e84ad786bd88c89bdba60f9a3107fe8dcb3c..158d1bb350f05d36f11145a591b4611287621fe7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 653b43915dc8b77b995c90fdd1585f758c7712ff..b2eab3c8738f8a9f07857ddfaa52bfc8e8a1116b 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2007 - 2013 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8e740dd47a1a943a8af2c88045c6d35c56dc41..0d7a63f756abed889e49150687204274ac36728f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e7c13703b8d8b52a905842380ba3cf40bf5f1fb..1aaba821aeeb686abe60485de2f4e8c18b686494 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2007 - 2013 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 511ca71c82bf968e2140b884862cba4ddf49648c..21724f754f532f41a5a59a237f2989fda5894a24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e74bea30b13a4692d3535bc791282c3b55efd722..97391bcf9cb91b14035eb47957db3875c4abf84c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f3e760676bf051d2f3725d94b09eeaa65316927..c85f300d25556b88e270c5b7b74bd060a4a636e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5281a0ce29045490397bb95f5c015c9a74da1c8..bd046b3ecef18a41d63b6dd822dd15f80b62cd77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81c4be2be6b1dc7ec29d05d34b8818683eec79e5..aefce3148b6c32f77086104d9b215ca19a07bf6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50cb99d5153f7a64fd5cc051406e12aeaed0a774..405899a094610f2d40a709cab692a55cd02ada48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c7331c5d50bd1714e0ed9e2774bc20410b120d4..71abeedea09891c77b7b5d6ad7fdca704719c5ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56d599fff63c17592f08e5db6e9090ca532b8a7c..3e708912afe7c1bb7d863224158f4c8c36c0d5e1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d964bd1ff395656e9676efa759650c0eb555d03..1b5cc7d9856df74c9701742a126ab94771a3ece0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e2406b498757910b4dd1e3c7331a643c7f3f866..3eec7bd7b708589d67a8d5a66da99dcd65935067 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66cf63c1b9dde37445ffd8189bf67a0b5b92a2e9..20123a2442e0cb151d7350038097b0f577c61643 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ce4e78969e63d194e726175befb1b400c9636c5..c74c404c5585da33eca95bd848377207e4dd902f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea4c1b1e8aec69c4cca81e0fb7390e0a660b8c53..e3da9a6588176375ebc85dde300f4fe2e274040d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38101672d5c8b7aa231ce1f36274cd24cefcbe15..e5b39a7d3ea1b774e6292013f39b5ff2d68af2bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c64d517f1a56f952064e0a0b2b46908bebb1d3b7..53fc86edc1e12df4f2f9c456322a1f783fdae15d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e4b2ebe1a4f9d24f1acaa72ea39f10e79ffcee1..d86f00e3750538e1864cee2e14fc4adf6fc90db4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d9efdd622f85a7e293b0259a15bbd4c157edc20..21fdd4c1613a383fde3292fd369ff064e30def84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5b2fe19fdb7a1c230ca9b29b862d4223c0197f6..973cdd6764a6d074f5eae78bef15411c9852c33c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 442da73d9df49ed33930573054107ae572fd9c97..cd105c095351bc1fdc3724f3eb46e7a51c0d16d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7669758b9f7702f24608fe898b9657ec6f91a57..2cfc7c75748324f450fea7611a5c1358e890ace9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9ee80311451fcb6220d4117fa1661b7db04f44f..abca78f56a2289f3d6fde258f122a0c866d85656 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd44bc7bff51a30ccc8e8988363a990b7396eda4..f5e0c1253a00e26901bbf55f737e70869e54c7ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e70de255a26e82f668ef6187c46a722c1e210e70..10bf4c3fb330e0d82eec64175308e8f6ca25cb23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c94fff8ef4b6e80a7238dff11844d4a6def96514..2f2860bb21ef2ba26d850aedfa0d4c7e31996558 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec596a92d3b46c708cba3d53494eb931cd906a28..61fcb9ad00ae1b5048aa8ee45fcc66da87828a5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30ba17c453c24f155a9b00f6a81ac37cb677fc23..dd9e65b0dd90a95f98877728bd4ae86bf5d3ef95 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d6e7c1484b1e1731aaba131483afde051db683d..569e7950fe55bca54ffbc701de1df069825835b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ac86a05c3849ca6ff227bd65d4eaccb0eb13f0f..96a4de63878f856578edf1ce2a3133554579d6b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3770fbb5135d7baef587e0c0ec3eb8f5d936d98..911b65e6d37f76152ba2d98fd59767320d18bac2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77835074412a537cd8ebeb542d58d5058c05aa1d..4472fb1abbff30477eae1e2e63caa95a30236212 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3baf6dc7e781cdf7f503a6372fa6ab6a88d82420..a81a6d6f8823dea7631c6ed8c8d6e5892c86766c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa477f635c6199f978d4cf1d3dbe6c50048b227f..cf9087ddd8f70b6dd081ab58546e8762f9440d05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0142a01e1098d089b1ca2179ac642ee65aa1364b..66eab34c4c69ce53a51a21f0cf833c2c8dc8a6a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33c8b9d56ff90733a138ced5bb00f5e015b374e4..3c6f6c0197b92166d50e0d6f8eddc634d7eadb81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 310fadefb22a6b38ba6304534e48975425ecd1d2..d01ae8955983c027a0b836ed121a3470fab01253 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b15bb2e0cf3be2a0e10a76712cadfe82bd2b9c3b..6670fed9472106d7e6fe72bb73af3c95178762d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 932c1b7d31c072eced5973ce2b424385585a749b..9607de7b0594d956343280913a032aad4457e6e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6052acef1f44f6f464e5325615e3267f425ce8b7..5176525b3294c09c7a34d257832ebc6bb81a321d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcc8f4a0bb537a113bf152efa5e23daf53df130a..af3ce94ccc6923a0d6a021b95b7bcf11752b758a 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c64c41879d2fc468fcbe0083e9f379308f4bc236..079c0cb68899751214dfae6697e0ebf5c6e4e97b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5aa71ce0b8b7c48f1383a9a24e13922f9b44b676..d2701d7d38140cd120a8010ed43fda1bae016dea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b63c83c954f5ced089a99c6d73c836cab62c4fee..4a276ef96610d66ef6d1a9c29f2afcc09779e7a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6b3483efcbcbc55d530f9d4d6ce7c04e6955f9b..d0e03b3bc68640faebabc9f094cae7c437f9dd8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2013 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9bdc62e9b3399cc930e32ff904635cdd1e89ce81..4e7d54486fdd77eaba9fcb2c0411aa5b8f242254 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e5a366b6add3bc9428af10df3a94ad0dd86326a..fb5c06c81d3444102f6b59b6c636cabe3880b5b8 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2005 - 2013 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0d8ea3124761856f2f2d7b65198fe9cd94285c8..2901bb24f8af92139a8034836fb2ea1bee03d379 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18c3009c7ac5603b63aea26fe370e178aa4784b3..80ed3cc0bd7a68d9bf082aa4e568bd5c729c2a2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2f5b6b5c9b43cc4396da0bdd017230feb19dd2a..8d4d389a73b4173a5dc1de97083d8847d8675468 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a434af9d0c9a5e6a122c92d99ccd0998f50cea6d..4516024fec835b5093742464bd25a24d7a73bf77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 720917c1642036def9639709476764c20e76d7b3..f13d0de6b20d123fec6e1a891e60ab304176df25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d73c0df53fe82aa457dddcacbe590ac8ec5528e..5e7460ec57da4e63ec971e851ec2e4689393651f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d78b6dd9aeec73f22df194de06a5f7a6742430c4..3edfd4b17b510eea9632be958cc3379e87d44290 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02910afce9adfe0c6b1182103191e7efaf9af5f7..e1024240bc301e1a1aeacbe626865ca76229bc79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c6fb6a82d71cf0b6b7a7a4f9b91c675f91d81c4..856d4d603a1651b00786315895894604e1a11ea8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10181db9ead1e32ec65941cc5ffccff3d966505d..7392e799e022c2c9ba28068b7d4c95ffbd7302e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bde9d33693c05a378ebd5d6dbf012efb902cedd..183a35702bb41206d57f4ab0dfb4147d295b111d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dde756a13ab06906ce1f1958f9ad5234f470256c..f16fef3ac4977ae30a5af082798d6568f14cdaa1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bce86c136e036d04446caeab195e7066a85265e5..e8774fd9ca086824d2e642cadc637a595fad2994 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8a3b39b032a617ae4d17d8fbb1fdef3cd9ceec4..c50c054b54e7da6206456d00424b78b9108bf058 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43cf0b0edd261e805687f79fbdc83c71d5633f84..ada313f11d2246e61192cc749082c61419024ee8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c95cce7b46c6438cd9813dcea35b6497a2f1ce4c..5fd222ae358b4089d99e5a545bed279c85fa792e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d25d29221b35ec6034c813655b10f7dcaeb445c2..326c984d4b2d29e38383616f2475181af0b282b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dc1d96f01d571a45a656e2d22927a89e4a7b39f..5f97f7bcb19f33f79462b21ea0bd422704250540 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8664b6d9639f2afbcdb1f0c4bbf885c990810e63..a11926a17406d8ce9d30340946a01790ba412721 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b1a167ec3f99cdb2b3c92a883c1d46a3bf97776..d4821a4ec0dc69bcf35a2413cb9504434c11edad 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8ad7e9def04bd95f23e05be567cd010d57a071f..89544b7cbd35b03e51710db0a25c26e8675d232d 100644 (file)
@@ -1,7 +1,7 @@
 /* ---------------------------------------------------------------------
  * $Id$
  *
- * Copyright (C) 1999 - 2013, 2015 by the deal.II authors
+ * Copyright (C) 1999 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3e6682d7638e00c569f040ba1ff43af57ec417ac..cad59ce38785b07bea1d75dfe6887c705451fd58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fda4b7e4ca33aa713ead95dbd594f343d576b78..5b0e0b93ad1fac3f2a469ec5b0ce1dd2fffe22c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5a4c9e69139e50b7cd2aba93cf5871ceb937243..557463bb0ee4887c3c6bf16c88aa4fb84fbd7ea2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42ccae1b4f1be32e84cc6d1fd37313380b258282..7d209a78c9ed6bb76aa21254406da9cce9101f23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3e27256c77c84c2c6b5e5740c4e966159f9e967..bdd3f06903d74b02d8aeaa9fad871d709ea92c93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90f2e0062d66fd46123f300697d1b3b2f37bd0c0..a28ba4daea3a84a44f72ff263551a0b2428d7aee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f34fdd5b4cdc67cfb493d6a1f5c2a466b577e8c5..e43ce73e90738b8b6ed3ee241d49242f560f6273 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77735c27e41ba7589cb728f8c0abe5e0b3535502..38a0424696b4146dd68980bfc0384b68f5b04e0f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 229dc1e303fd5258b1445cf932b06a4e39df9305..c5231294ebccabe9f93d75f83c21dbc19282d146 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79e7a773c7a38b55a9b50592763b4902c0181190..704f99bfc3ce57f47fda2b2a599fbfc06afb4708 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 259b4450607bd1a946ca7bbf6f8ae13eed2e1d9e..0590645979b8a7055008c86a72936e990dbe498d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aebf61ea3585f1dea1a6efb874167a8b4a2cb86e..a3026bd4ce915be0a93fa85afde0d43a0a708cd5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc48a4b96001aca999e7f8e27735c8e888b32435..bdcac8f7c35685137468b598233b91d1b586e160 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a2dde72942bf1c5e4ff304ff4f0030932ea8171..70e30f8ec348bb9956020b1e67a29b48863b4876 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d88dcaad5cef06aa733427778a210fd016dda7df..fc24f2b165f229d0a4f76036fe3d9e03ff825073 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d83458d238ab9f7c744579e289c32fd53b01650..ce28ca27b721efc5d1268a0bc1396a034564c94b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6895160e727e2b3467371e18874fd4ae7c99066a..9e4dbec77d42a2e6197770907967632612930656 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9654d43b34df6d456d43e67a77e846a8becf7a77..1dbc26b134576a46387abbcbfb6b52eaf9e891b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 324520460a082763db0fa028ef87d106057a8453..e32ad90dbed4fa5f4aa6b6e7357690f64ad70ff8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16c386971957662face395c9a793fbff07d1548e..a6e04d183fc55154fbe2a17e4bc1bb2d053ea660 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3665cc561a541c718d0a257fa43279145ad5da8..e90262953ff39b6657d58c23eaba31b77e8151f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44eaef01456fe0b3372cf780843ff08fbc1151c0..88dda636fd8c111158f3f2e84f04cb3636193fd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a22a5c98d4eff4f15cd22cec5b653ee82d172d3..86ec292130f3e061720eaf42102b176226dfca63 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 409780e5b1e8fd17c6ad48323e1276dbc8032160..be8cca0d627f86c98d07d73d5c7521eea5ed5b5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0501039ab0c05261fe76dce6617488823cad6c65..4f983191c8bc53606db0eff52cf76436a844505f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e8c889d3086f6b33500ae91a903e09c9449123d..c82ad0bba5424cfa0a23e230eda5ed6490300b9b 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 158785380df3591b26c5bee99002ab6363a10d67..42d001a50cfc8acefb47c06de7def47debb5af88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eba00c1ba0ad558a772d732849839dcc6a10bb46..619a9bd705d08a6db5d2a212e7b2968ea92433f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c13e88c89b6a3714ded86a97c59ccfc8a88d1489..18a3f4c957c3dc933301452b40c5fdf18c7aec0d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4b287edf42b42bf43aef0daa7440bcee70a6f4d..f6480958020fd23a7406f665e83fd735edd5af1b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bccfa62160b4b73b859ef867be49196973d6ecdb..3f11b0bb0fcdc7f25228de4e203cf58ed8ffd68b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b40ac9c2b060e42d5ef0a04e534b9b3eb227a8..29604abef2a54cff74e3da99e0ffc71e8d8c5729 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac450c3be056c848e450bc49096fee1552eeee20..7f3bb6e29a2728496b42ae87d11e85bb02c3e737 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99141ecbf2785272dc46b884a66f7216b7c3f07a..1c3e28dd880b4834d124b2f0995cac3b6ae69dd9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1aaf9fd1e36121c0e11d1d4b5e7b67dc301172d..3f665fac2bdaea077828290098f515cdf5203062 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9b86aa247ffea20dbd93e0b7260472f579d2a75..c3ecc9912463a45c493872459955f8fdc814f443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d84246f63cb86d9e19cd77e906972058f74dadf..8dfdb2caadeff58c7ad1db6ffe302c60572f3611 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86c2f2cd4ad6f0630983933cd92d479d71e624d6..46b041029512671c399296f52fc2117d8022f228 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27d3b7fccef6625938569ae27a39788e101e652b..199bafda83be48aa97d9135ba656f36781e5130e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e00c5321f7f47ead47eaec128a0a30e1e1b3ce7e..9ec508d6677a7579db17074468135a66a18ba4e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16edd8d4acaa784b59daaa8fcbe8794e54634f40..2dbbe8506e92a9e3b59102151cafc8d197b36671 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b20d566808f980aec9424667afdd5cb8b9258bb..95f3435e704d64dee107dfb7897c219e3eaffa76 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4e3ec306721f3452a0b158e0348be643ba60d46..c12efc7a2fecb92fe254ff32bd67572599798ddd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb0a3b8f2b06adbf8a216c811b394af90e5e4dd1..1f6d30e16da44e95e7ed9cb6dcf41106b352fdf0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dee0ee8e5a1cd9251483a3dc4f823895bc9af118..e26125409f4fc30e91010ac4a2f581270d204132 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5b6045d593115a23201351f5c9a38a8f57b1893..523b742f56113e8d134770d062ace2576df241c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18b987793598ef05c41f0758ad1c5dc46fe65745..6bbe54ccec2b6073cc6360736dfac8c087b0d62f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0955c2b256b7eea69dbe3760b86f814c07c8e11..3f82800b6e71984befea51197c037031e73b5d40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92cd2643054d2e744e1a91b6aa19ddd730cd9901..de457ca5854c87581d91b3709df23d0fdd51e945 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4305ec6658502615a6e49b195e479a76f0d69a2e..70de9a9ecc3ff60c865f2f79a0464279f4c3a663 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85ca1388e34ece185268090b2c0e5458152caf2e..807a31eb86938fdf82496a9652f937bafa49bfe5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1711887b70ead770e77123ccfd00af74418b7561..790718ff6a1f224e6ecfcafe0832151c39ad3fa5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e7b1211984d1e68997e870f9b7f5d3437a226dc..5f57b400ca211bada0edca1171879753e515f25e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66b684653c804e3e992754ae8ef2fdf8a117c496..93cefe25e40cfba3d9286a5f8380efe08fd6fe42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aec2225b15afbad3b7350bfcfd03c216e65815aa..d9dbb53f5b9f27700729eeb5ff5db692516cd8b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b532d93b8266c7a01bd6ec09176c2be1d86f7ec..b36dcdaee5882102001699422506ac9b70385e17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 386267c9c6e6043741e1d54198d2a9703d70cea3..1656c12151e7546a122e7e0153dda6a89596c2cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf61f31f54e433f142c83d4e63fb207905fe107a..d1ba50ec743a5a531dc03c008470ecf6c5ca2bd7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78e8a03bb6a5ad5d4e1ecc57aa94c5f785ebe1ae..3cb190315bf4d74e3e0de75bd9f2805d97f020fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7658b4599f17b4d8afe0cb18920a7e972cb01947..8aa3688da00de88ae01a63e1d76786e712bbd2a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36fd44f12fb5accd5dc79caa96f169f5de895ec7..9771b7632cb1ffeb205fcc624eff46fd702791f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 883665e91a864324b51cd483619e7205a38ef8c5..170d4fd765781a2c71e8e03a047cb866e9646325 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 883665e91a864324b51cd483619e7205a38ef8c5..170d4fd765781a2c71e8e03a047cb866e9646325 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 255f6c1320abc672e795e9f76a25bef374151f32..dd51733122a4a4a8f2cd12be5a291cf2e66c6fe4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d47fad93a72e6fd79c9fcf795090601e9d2bf2f9..cb5e575c857a3f4057c12fc4fa8ddda37bc4ac89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c88dd86b59ffbd24fd147c3f767c6dad72162aa0..4e367d370bb58f1e7f602d5125b4998f9fe3dafe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfb2bf1d8abf03d5d88b32c1266d3259d7cd74ff..c8a38f5dd9784cb74536e5a8a5a486a192a05b0d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc707851228870af8b56aa6595ae8a890a9d783a..64e95d23ccee3f9d31c3534c2ac4bf391dc5c7e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc6647b6fd001752a5ebd98344ce4c1df138bb26..5e0f346de0a3a17ebb2a2d9bc432ff3a33ec6431 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37f56411123de35aa42f0cbc3840fd276467b62d..3a9918ab2481a61b5c75eaabc65fe8cf5e779c15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76843fe31045e999e8176f39debf3ee496f76e5c..9d573eef05f007c9049449dbbd2e9040bcd7c782 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50a75c530aad760ac8edfac4070912126e6988f4..6a316bdb7f156b472dbb601ff0729aeb396df818 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4411bd24a23e4b45617c0e9f37fcdd21c7001f9c..219d26c35580f77ece2ff6373644ef4c4bba69f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e83bbaaeb068b629c323efe1eb2b922a3aff0df..c82de7f73e76584bc8cb9230e981af54d34f0d18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50901e5e7363e009a29118e3bd7f6c1db5745730..72099181d8d95ab585a96cb2e61d7af6bd1b48cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f158f950f05c2d183e24c27b78ad8fb308cbe3a..c400d13ebb5bc6acf9d4287eb620edebb194bd82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 492826de0b90c5973c719f1725e5967915f6a395..3d8105ffe6683731707bbfbcce6bcbc4ca11621e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd9aba56dbe2f28fe12837904a68b37c56533859..cfaaae1a6111a39edc2828909dd1478a59bb4d17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42349f577691c2ca5acbe24928a34480ab54f2be..4d97b036b8d5f2ec554fb43878503f67a6c7f2e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11ebf92a884a3d84e27293a9debfd93ad1eb6a6e..60235a56d38e9c8c169d9c367d37751c0be21b0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94796cfb9720e95d743b76a664847d45a0826a7f..7c9d560cdc8767d0809815b5fe8113fc0c6d943c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6a5aa81f2a665b3b6d800b7a4d49ab383f561f5..de9c7740a05c618e23cb48090286e79f8698bbf5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 910f463e38944d3b8a5a8c6f188dfd74db9a8fa8..382c2868ebd4bd73dbe726cdc1538b85e9d3028f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f2db88ab8ecc456a77e3e1c1e32d794a07d041a..c2b8a84d8c0da7141ec983396473790772a07948 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7d73e9ca46f66b8e6afb9d7bd14478a1e7591f8..93b33c6161a1d3b6d9f7c9964f64fe4d9adc69ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c6e20712768b6469eca01a4dde8fd7507b11c7f..3006467b505d3d3da373e2f57706b820cfdcf5e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f736b99b0bf3bf66aa81ed7d5eecacefb5f7b5d..ff1164663746b38e9316cb0354ab75e573e22d22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 629c64d669a2a90044494b7e969d2ccf3ba87982..5b612e612d6cde7d733efcb360651d037b98a0ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5f433a52c2c193022d6fce1bbd132367dd00a44..c5be3e720972ecfe7b6aa23ed469a0220a11874f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08c098259eb046e7b3156dbb68110671f1d69262..585047ddb7d2eeb42d23d8488c17c1cf30310534 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf6d202ccdbd5420bf9ec33cedb7fa2c7e1b200f..77c3ab1abe496cf70a964fb8576fce483bf6b358 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5edd7538f30a85dd5a3cc2eaf585173524ff7cf9..d7def32548c1c6145e4df870cb6c70f6219a9584 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0ad50197cc7c8778d9d2fed70719a6c61471dce..b416ab4ae4dc847db2b0683c27e22eebb6faac79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 242b26e5d0023b72d4f3d990e5f599c29c555815..264a15653609755ecbfade384520a63b1563a65b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e935acd65332f5346ee84d0f23ce5b1ef58083d..6a4dc1298295b162e14fab9c8d71504a1c1893ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8075c14c10d42aff7c73da9715f5029e7e0b18f3..2f961b4c1f1cc4959185aedd04667f2eebe1d71e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86cf5051299bfafb56e47667743b116ec9b1bdb4..539855cf19fdeca423f9b610ebb6a3b6b8578ff8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20a7c219ea882c1a6097882750a6386720e546d1..8aebd85b38481af2cd2360a18a856667f58171b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27aa2d34c84ecbbde4618506f81a6e16ab0c4e1b..faad1cc4c3ba49317c97af057fa91bc826abb188 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7f62d62aa12275157170a8f6f3ef1c1b6f90412..49d50d993e3dbbc90cd5bb9fb7abbd7097d52f40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e61bf3809074f843f12082375984675ffed7e81..8b7f724e529a97a61fd8ec6481627ab7fb02d1f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a2d813572b7ce58bf2b85878cff7c326871ba76..f1bebde06511c54778ad23604d7f99f81545fa83 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b21ec001072005b87af859c14c49df8d64c4430..fc434e3ee09acd1d7646930d9dff1dbea9e1b2f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed39c52a0696f2730e156b7ac8adf388fe9f9433..8097f5791e4e23f692f49a6ec5339dbd9bd32b05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bec5005014e658786c30d46f77fa4b3a5e79afe..88bdf3d368335ba2e3fde44ed260b9f1307035d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eff9528f5dec8edc725ec0abc99a82f7d3190989..50f7c43e8b6967e0131e4da6566cc1dda45d41d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f218c122c4579b6c492835682f5b5af4ee8e34df..58e2e7c20311cd76aca00be05e0d05f3062dfd11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35f3d516d6f46639db416e8d323d82fb39f713a5..e1601b507004cb8f0f7dc9f0c885a05ea0531b5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f526de5a8d811d77a928594b36985974e76ccd12..43279b492cb1ae501db1cca1269a8e8e7ba84fb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5af3dfb2a76dc5d736ac9117831a21d3a2d7d895..2d68b2af98f0a57f01ac25a78ecaf8939a25d394 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 187cf0c904ec069a34ca00c470c8dd3f69bb4997..d86b5f67119f5baa3263cd62a0d884489b53ac56 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a795e7af026ee3b7a54a8211d11a8e91e68bf5a0..33d1c1fc0bbbd0d30828ad6e120d0af9fab8ef15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d531676c861da87c997e0903652f3fcb89e47a7..209fe3c9faa55c5fc798aa46b0675eb9f3b196ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d5c7f53553d42b58120fcff3fdfc355fc8844b2..020601f7850ab2ccb51b3cb344bdcac6dd549ac9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf4b2e5b718e60fb292759267e286327af48bfb2..ea87165b7609856b7867eb138f4c40ba4f9ec728 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a101ea4b94c74d0e11f70af6899f57c6434c3fd6..ef0b8a8472172f9472e730a9ccde4f999dd84eaa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56f149900f98c2244a32f8caf066ef62aeb303fe..6cdba62ebd35e7feb503b21a2d9268abbc7205c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10af0350133fbbe6b4c4bd74868244fea729cc7b..f279013534ff878dc13e1c666a1d86f050565aae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3241594f7010ef5f1e79477a02349914ed270314..2a90a2d317d0ea7533109d13872155afdf20ee8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04a95c72ec97db8b201398f003521545b7ca694d..25ad5b1cdfd7ae0d2435a84fea29da11c283b792 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30e361b8c2de66d1fae61941182499ed1c2885da..efe8312ff9f448dad466eb35d6d257bb86521242 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4cccbd13093e2bb8092363624c752c71856024d..5ceaa11c343dc6bc6de0d4a563948fffb768638d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dae0a30bef6f09e3caad229da4d4d65e93a446ae..3180f2a4f28e34f9a0a5cf5a82afda9a123e5001 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c60aba15e2f25db9aa1c9f16eec3d2186d642dbb..3cc330ab9c7ee7fbb615bb5a48e57c5f114f34fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 147d77e1979411ebecc98d50721005e74cf6e716..aee8111474e866cd8452869ac4f05b2a259fe032 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff0a6fc891579799805de1c8730779a76b48b22e..b319b084ffbd1916e5d7cd6970407fe3405481c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4682ec90d298ad8a8b8cbe98cf1fa90289bec5d..115bd8a0074dab6ac2e4103c26d289b5ae5c569e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f94a774a827e93aca2d8c6d206406ee77e0cc782..4f6d87d7707a41f9533129d250bf0218f1c8029b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14ad7eadf0553112f396e7d4cc62ecdc2c379c68..53f512be0c3b66b022515860e06adcb9f52929af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5b2a5f61ffe97213eda15e50796f4986ed2c6bd..8faa9df785905b7c0bae8aa7a9df0a0ca4aca5f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae6dcbc4834e79bfd0afb2bc67cc37ebce4420e6..6c6b127e62ae7b636bf9f7a9ca5eeebab2b959fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f87544e4f80df0d75c1b8f05614ba75385a2399..c0a10c07d82347fd89489fc7f234e5d722b49ee9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aad489bb1551ae76729d57291bf0e09ff5c2a977..355f435888ba1215b08d64677da45a00df52c78b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c73373e64f8e3cf029a244f32ea7296235a94c5f..0fdc05c7ad2f71313f590a599859ca3c91ca5e22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d2ab3fba08afa044308ad696b73ac345926aacd..d7b365a61425f5f40b9e4b9b5d790cff1c8e7684 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54a9e782b867bb7517db565876cf7e36fc228e5c..0feef6948e4f59b26ad3a94daf9a62a94a0525eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbc9e918380fec70d68b4b460f2c842ac0608b8c..e1abe304118c991293afd782fc575dc1e7d399f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9471b0b48ebb9a27ba764dae61fa003861d58028..5501715b5bde16c1553608412acf5d2098dca089 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10722dcf67043487d71790c7462d340ca5ebde49..6558a06eba927489bbdde8c0ae888fe54ca9ce23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b564231524aacc31ad6bb02437696916f3dd3c2a..2683db67cee93e4e4a82b7bc9b223d3e46d4c441 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6368e12e49080f304149ecf1dfad6ff12d2d285d..4c3818027063896f9c56888636b17f89dac50971 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10ed2c5ebbc57ee7aed840b36390e46cb638edbb..c63ec9c8bef4f2c0747e6c5e21148366faa3a7c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9d0218ca361eba47e4f8680a6a7952d5845b995..9ca518eccea5b86bfbd43adc941ee414be5ef3df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 411977ee5e601fec809a58ba8d21d6436303b28f..074ef1cb961b9958fbcdefb7feaac192182154e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e9e5f04730d67bddc46999b7c74cdab424c059a..5fd8e3363f7ab97546826d6e2988351f5586da7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0f931959dfeee970cb2bdf5ae0ec383fcd1e3bb..8a276acb34be2ccd75ff6177c05263d0431303d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ffc5764b25173f6e9ff9f4a4ce6476a36ee2940..a7bc4ed64997c8520f9fa1d8fb2b7a4991202a04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01be64b42760339b88270c19896f4f435f9e4a83..b889ea03d7c15eb3d90214e78214beeff2448162 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50d785eaa54190b4e7bd030930dd5a7568db1088..55aa05881d4f759eff472b3289be41d3f67fef4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e507f86293f4f12ee536d72464083b7fa8cd4c90..0a0ffd3714f2b476c5ed38b5ab59d58ebaeff0e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a462bb97dc49a7f710e10329515c1b3429b448b9..b5c7a634733ecd7ef4d47bfa5432092a72061c40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4338431a2ddc731b1b7e3f33b14ac08e417ec779..18b422fffd0e98a8dc25132fa0308f2baf55b40f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4023a514fd99c6ca7aa83e7d9c59843934017979..291c360f86cebdf7701df5d7ea98c6333f47a94b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e332b3497aa201804e0bb760d7fb0ad34eaefdd..38b8cfd6c75f0543697cf069663a839f127aa69a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c34071046116c0d0344e241dffe8ed182999d21f..f70b54ee39a491e2f2691f0517e862d740e2c19d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa9951570fc7a9e4cdc71eaeea3256e81b8dc940..c1f0b217afb9d9e706a30d9b93553582a6071f53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b048e53d915daf44bdfd4c93bf345d046666ad2..f765e448d51e39f66e8642e5fc919fcba1596d65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a23959347a3c709dd1d38e32916c1e91dae98207..27d19dd88c0a518e31c51ac62484230418dd19d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fac840a351c5cf7ebc5e22feb43e5844df2615e..71e86ea9d51f621a347ba4a01bdf8b611a61e40c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17dbb74057facc3ce4ea1151bf5fc811f878af7a..a6f29f96ddc3b5647f40ea4e4bd1f148ddfc986d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb1210f12bee5d22569044cbf195ad4b923151ae..c070474bb9ea8a92ad0705607802b2caf588d8b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26dc6273d50acdeda53ec258785a22288989e7c9..dd88a48b0e9fe22f8bffe6c20875c91f8481706e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5140831eee27e5d2c593d36bf7a7bfce8e4d185..24e104526dbcfc3ccfb0f57e6a62b0e98e5c832b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4f3e4207ed519b11b2a851228e7f3fb3caf5d79..dc9a8ebb5340b01b8b78613e20f3a61a3d159a26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f6bd44672ad5ae2f5157b23763ebf7037112243..7df47afe5dfcedf4393438c5ea46cdb1c8b62f9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ed3651b8f7e1159b5d395327955ebbfb496c118..cc82dff247e789e1fbda098a9975028982dd64cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5ad2372b4780ba16eb8f07770e2f225333dab4f..78208216e585a8b39e5b0c0527e152715f48c723 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d96a093b82095e3e69e9ae5a6cd2419528652f3..a3ba62173124653f2d2a9a329df005f460427630 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ab329aacd03b0182306fb44ed0750fc1ffd17fb..0505ab31d702ce5deb946d21a7de0347c13bdb60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ec3ea4c862218c24d5abcf6e819efd661fed077..a08f7a6839f514212fa338dcdf80d5679e445b6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c9f3cf2fd43f8e0cd4180fd8a3d3418907a916e..b8079fcc13390a3945af87ea83e6b587f5a0a85b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4fbd4251b3614cbf06b3862990e355dc9b47988..dddac3e0d50fc00f222d3a6743908f9e7178c4ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfdb0d2478f9fd8dc460014a88efd742c3aab06b..abf963be1389838c04a948c072ec5eb740a23e3b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e632589456344ac5220fd396a51c9fba1366004..ac6f22805c6c4351f95c96a79704b05519fb6ab3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 011a333f297ea3d7a11cfe33fd3ac22a79268f4d..45cfda76ab0dd017aa8029ac595b53334feca8e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb8970634753219c0fdfe2ed3f8330d8fc23b25d..a76d9b30d24086f708e00fdfe5c9495861a1a72c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93a173b7efdb9729f256e3c0f950f5483b83ba30..3de472594b00247569124fe2df754a31333c23b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b522b6a159b7ce646205b3d4e258752e784f783..64615e1f7081b9f219a972360858faff6aa0b12a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24ae7d6112a98c52f481d90135c9ee5a44b31616..d4fe4a7296baaa5930cea63f1c43bb30b00f1e39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aef9c695ad1e79a9b3e7ad308ae85e7b647765c8..9ebccda96c62806632d00d3388027dbf02e2a19f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b1422b87fed3643e1066c130465065c1cedfea4..60895416253a98598024fc44347104244b00360b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 375aabfd04238e372aead73a87cb7a77642a4e47..88986a584d31e8e7be21b05e202bb7d782de0e80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c832209dceb26f30c104c52fedd008f0e0b11042..cc9b9629ad676d2b52d128d9380378b5c7010279 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc4989a2ca429b88704e8c91814cc8ec57fbd398..ab972f9ad88ff0a49b1df3b64061c2da97133d8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87e683b63747e3e3626c72451fa09406abc8ac8e..a75b0a3a717e4ee1c6443b65d3f0230b03e7dc29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c1b906765cbe93b59b99c2cf627df5371a5af47..ecdef02b6f340794175b9a55608a892c11074ef5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6df036f57d45cb7e1884e3dc56f6d1995708c7cb..74242a216f6dcb38aa5a764f38a2ec2a8b0fb3af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b77eb7771b3dddba724a87db54142af522dd71f5..3c6ce89251d76e570d62ee4ecce3b24a1087b419 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75782adf92d3833aa46b31c1034c175322dc9f7b..80748ec0601a5988444510f37e5bb45637623e27 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bf785dbbe8fc4130a785c223886498a3205c362..b9aa606adc3ddc31078b10af86b0da9068afa526 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8613b57a2ec525b59c3deec6853b4799a95b0fad..181b0c4a05e118fa9433713b6be4ce6af126d8a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54489e8454d8fec47d33f34999fd3d6d91cb3043..126e69a16276c09cd1ce5a86e67b7cae231c069c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6eb16c52977b18a84089d780384a71d978d2d551..283d10c574692f64d738c189d0e345aa513ec043 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f76b1d0d34430bae52ce53954841893be1d7babc..eee58d1c112525dfdeb9cb00149b817d8db0b047 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b001cb57c7c003454d14f8e855eda36fe0efcb85..aacd09b65305d93d6a458a8d781fb97b2e7e7ae4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d86cd4f0a541c3cb6c4aa9d0f81b9d19437529ae..6bb86e7b614511ca29b88ca1a9ccd4063c0228b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fe7342e0ae4aae36a33de86e616e5f22b72569b..1af457300f124adcaadf559fb75580615d9c207d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d3e03ea447a35797ca564a29a0d26055758edbe..ebca5d154e75ef22432b160d9d0ecc176f9b8400 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8582cf65bf5341c5c52d43b371f3f6683b594a1..4703326732b0c38f20738638c4de1275389ddf68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae899847a82b08f668d0890da8cc3cbe24969195..d752ce031f3331ef315d34bbdbec19f93c3c0a49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa7ee342c4a4075b9804e5a7e9f060f57683509d..1b901f8db3b455625521aa7ee7b61e555ec74c99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97640c6b76a97b03b8e3fcea1fabec43fd136644..73216af67624efd933c034a826bac74f68438f85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44fce39ab23a0f5c21997c03768155aa3a52a69d..fb2175f2744b1c8e2edec0442910285595a745c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd1f58cba219a9363b74b86307f7c68240ded742..95b56d8e61d87bed781dbe050328e580e24b9566 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43f78b2eddd430eab444046ca70d74986636e921..b1e27d05dcb547eb1dc85cbd2424d7569126b31c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a520cb84577504bc9526ebed03d88a42b0f67317..836c6ddf086ab95f1c4243d32a984dcb5de67b17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16056409b1bca5228d98a94c1e2f13124512f558..311a67084df5a6e5271be4dc5b9f0d09b453b945 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 882d9af2be5000a7efe4f1885fdb01f235d39276..d32e7c42d1d9e0314c11926242a9566e10183d49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94d7fdb77ee7d5c76d479b64fcd65179bc6f888e..9c3cc579a1d0e7dfc23f1cb931afaf13168dc3e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12f2b20da036119b683ba8b924b48d03b5b3b294..e9b63a8425bb69b6d8da42f372af3fa542f5a8b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1101ae1a2abe79b1a4ce4ef8c49607e26a22d531..02afb7d375718f8810896f5eb3affad457c9ca34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 376085e897ab36aa9a4f32aa121fafebd823f37e..15dafcfe9044b256ff7baf9b70428bf523ad3b70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0d1b38d1bcfc5fd5d0c14ff0497050a0b2534c2..c7fa7038b18a7c5236033242c0ae84b04a065493 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc19efbd9058710e213e80e8b1c570074df6377d..2d099ffadf183baeddaffd5b79668bd9faf77b00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aaafee6c758c81b958fc81f8403d4071a8f776d4..5534a8e21175526a5f4c811275c1c1e828ae8fc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02c39b47beca4c7fa2510bb799080fb4a065b395..68e755bb8edeb223e86eb6f91581ce220e86cd2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e02afd8b1504ae0ada6eb009c874770bf33f9a16..1a82f4300050cde0a5589c7446d6660f66d24c3b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56eebc1cbc8c17d89f0e2dd3234d54c020bf4111..a9ede2afac301cc0b023d35524bb8387ee0cfe98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 069b0bb0ff8fedc68eba8862126e9fbfff7e59ee..738232d2d44bc3f17ad1800c7dee0895257391fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 377050d1537ad7b3f5d2fac3eab256486f89c5df..af69ef7ae0d3dba98bdffe1892e694cbe87825fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd2d2fd4ca313b1136561e2a192ee275816cec4e..e340def3047618e51e06623fd2cc72f862ce29ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edfceb807c7e9761e08afc9f2eac20391585927f..a2d632e2cfc1753d79d6992be191af09e8123da2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ad474b667280b25b797de2629eb7f3a77f6f49d..939541f5b9c9e88c3a50bea2c7f1446cf6914f4d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 868dd8fc7c3b5887300dfebcbfada695dcf99489..efa915e536b2d4622f0fcd6f6038ba212eb6bc96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71a4e7b00c0c5adca6736b970ed6d166cf0f6bd5..2fd590b272843b6a10cfb22e5698c6c8797c7960 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5acdb2977846cf598816e4f557ab4ad46712b45..b89d58bcecec9a3867ae6b908a8964521ff2dbcd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f91a08dd5c61a5d09fe3036b50f81b9cc02baa2..3becef28d980568b894e14e93d99460b1e0bde01 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d26b49b30e779ee9b2aa8312ba460b278e3917d9..91abd9a2d8948e94cabb4f158e56a4ce2fab11c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f146cb80c0038c6f8a4fe497d41dce15447c317..cdea7aa454a32b16c467d3198e64e4a3d44027a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9639d02b0655a3cd6261ed128cf1c7d378bedff7..562eafa135008570ac5bb568af9718a6c5ddb776 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cb74940cce8afdfc2c8925e0b2f66b69f727427..7bc0ebf46c69e095633b02f32c15de24fa7ef550 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8688797d82f4b6b85c5e209ca2901c19638b735..99be3a526df535e9ec0549cf676c8510bc7a7dc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5dce0541b29b592b0a97f2f835e623969a50db73..7a1da8a606110c2e8d26758d85bbb28a12addb58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e2003fe35b30fa45cfa69c6dec7af72cda30d09..beef033a4522731761ad9abb4c3518e3bd67fc08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbf7cf57828b3440418b6ce7a7455c9b25f8daa9..05139739f615c658de5a645fff84e89d91d136a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 015f92b2d06e6854ca2f16198b5333d5e37d7315..1056199ab2cafd651849fb36cf18c7bb202c3008 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 622b5694dda7b099ee1c7ad98463d8c65420959a..f86951782f460a0b6d1e1c4006bf568af4eb577d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18cfd394bdd986e082090f43f8b2e3acac8c5fb4..33b50c698d6b426155ceccb83a916ba15ef079ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 965e1289175d16f6480f5d66c6cd111f4caef5f7..26e722b036c78a58d9081d2bf5f28b7e5126ebbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b13a077651d68329d441a55abb1275d12e21f32..bc2012bdfb00a6c1ff7704bf6d767e5c98deb532 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ca951abf8531417507caa75fe99392d8dd2555b..ea0404ada987fb437174d8d54e853f67fce56b16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a49eb28760f136c1b2f9e20277722ac0b4d4b01d..f470fef458f30337812d0aa9802f5df4b3c7b643 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2024213e69f084a0928aa4b972887be9a075601d..8194afc7660c6f7388b4ebda001feddbdabae949 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a25d1c3d97b214316cee29c00ce08c2b81ff9c95..88bd9e439b5634143d3a116a9479741d6371bc13 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fa9c65d3a45854d0317f03e1bc99cc4ab0c9688..5e6339aae19f33f2a1fdf090d9b79a84b9d90717 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69fc0b0150376f7034aa240a56a8c34fb2c252f0..9434990cbdbf4cb1723e7324ca5fb2a1876b08e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfda34a9ce566bd1478e2ed17fa78329eef0b237..1fd4bc110215bf4cfb378832cf8b2d93495e58c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ed037bb1717f7fb9337e66c6d752cf4a66f3c93..b1076f11cc09619829ea517e8ec3d012a41b3af9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f467de01389777180396530b85390849b4644991..3a2c9e0127b7e9d916cef8c83dbc6cb13a519aa9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e65820fd37873d88f631e52c213b5fd0ce303bfa..3722255824cdfe4824860f592e857234849558aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0ef74d4d66c707dcd3ba902ede858a446b8ff8f..5bf48ecce5a49f44d65fa23819dc2e58d3f28f44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 542e4f9a5687f89c9481e7215b54099b38dc55a9..0c1e5b748c8a2066664f4a6c1c2d5ac2c802423b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b414a2d253302c0021f0e3d74c05ce2a6907002..018881735ad78ff614b85c8df5c35d68a0cf3bcb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa50060c5df1b05fa3acc42bc3b3cd8e1163a8b6..0da867a59676e199354bc2cf4816309f2fed5c24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e14a7898da02edac50b1855f3348f10f9344240..3b8817703d66e9d7d1af08066d4d8c899241a151 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bae372a1d4bc66d046d0189739c6a092232c7895..18a27e9b159f99d91b6f7e52d681ff9db5926499 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49f4bf4ad0e6e4bdee08557b49a3d9f9b94c32b4..101440c175a1e11add840914199b864f24ecbb39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69c9dbcbf8d04fb021ccb02784f32e4de79eac96..9a341637c03e1bc30ee7a718336b00713398baba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 412ff9f2821594553b323efd357bcb036d4565a0..6fb0bfd98830b286240526af63e5d28cf01a3692 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d1be68e94f1105ab848bbe1d27df93dd0ca2f8f..028dcde3883c04e8a217fd3d74e5d12a58faacd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a23a912a5d4eaeb7e24a616a2bec5cb9127d2a9d..2e89124158a85ddfd2644726e938d77f3fe3d84d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d9b5296548f342c4322d6ce58cc70c3faeb7a6c..81532b92d20f5cdec17fa6fefd15ab44dc29b3f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50732debb2875e63ccab256fa64e4b4e05c0e2c8..1f06fcbc059fae894c5b585bd5fe081ed98d81b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4836b2101c798671a19b9bafc7fce069eaa3e2a3..4171fc14975827cb043b510681bfeeb31290bbb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf4e6fe966fb28aacb5318a17cf8c8f1e4f7b557..f594c6e8ca5d9c71d245878fb7191c9b951211d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b97bb3f40eaae1cd4823124f50067e351af0283..fb6673ffc755e6c083ea84f53ab1cbe54a0e9047 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 847de249a2bcffa37738f839335b355b0b2805a8..e26239fd708bb6c04c0cf5545bf9a52d6c847d88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c488f72b79ffec2a3407a8cd38bd32ec8c1227b..c1e968b441b717a27b2867c8266d2e6116e5c614 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cbf076b68b08a6ab08ac016ffda1232779b2c42..0f4cfb9683f7c3ada5d2b325dec50e02fd52c2a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed2ae2c6b9cf59841180f1fb20baef2978df7100..1e4af1b3ca149958b9bcc7acd479c36a024b339c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eab1826b3ac1679e6ba14e040ef2b83b566c70c..206c15cb1eaf70ebde0d173634264f87846dc505 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87d10a199a120e1d7064b22646b19f3962326d30..544179eba1dea8e600aefc5e7b1a98dd212c2c19 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a990085a88a3f914c1f2082dc84b0662c31298aa..5a70c2cc9c3a371885025540c78dbb0c1ca5afbe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45e8708e2f3a0c081efb228c46dac342f801487c..90643b0c7234617fed06271c854d35c0ce130e21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd1273480e29a861a1f9588a29383852c7d3cac1..412cbe901712b8451e6eefeeb502922080828d52 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f51b274179ff659ee8649c89ec459dd63888dd27..3501f957bb8b0dc50a947a080f9e026383f4a566 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2385f393e6de2e9576d60c5a67ce75a2eb1ba7b9..c96f992aeb1786188c29df8fdb40ebb4148a3913 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 216c10aab085477ed0881e09c8f9cd0a6fce0d4e..ee4a7252db4d49fb8064c9dcbd6d5d50f63fe38b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c48a7aa2c1b456eb6be08e98380b5a723a2a08f..a16fd0d02c77535fe6fbb1a442d88e7b9d1ab925 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce5221a313290db1dcd478b7580b018a54837969..ed4093610f3752d61713809224413eef72aae990 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 912f9528f35114e9607a7b8221c93a4dff34818e..b4f885cc9ce0cf9c662e86f7faecd9ce1bb536ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fec6bb7f7c92a7da87252c72ded9f3dc0c861aaf..3efc197f0793eb9a166391ef20e4da080c9c90e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9813908a1c00a2580f053bfa7ebbf6076b6efb44..8fc42296929bc7876fa4666e3cfdb17131e07f14 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a2723633928408a67673568305793c6e360ab26..809bbc21701761bbe522cfda084ba08138e40523 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c35e8e48677cb2ee059d6f95e49378ef9d43fe96..b725dcff25590637f2739217244832fd883b56bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90defeb8d946ddf47251370b6a4f0666e6e92b14..40e630ba6f4ec8258052ae93ced1310720f6b13a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1f6bb5816cfbe83880339b4e93a1dd2ec6c6ced..d211a985879aa4c696579ed05c4c5eeb7fb90353 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a02453216647f4cce5e5b072e29856ce4e04f392..7e16d7311a9b80cc12879729abe763415c68e972 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94b9ed38bb9b1a0be6075a2255d2bd0d1b5af14c..45a3c65420a804c311c0132fa7f40e3111c50f49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b28278ed286a30c92df3145e133a6fe9598c08bd..45cdcbe390d7745473b9805ae864d958c52e64ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0af71776b8c9395868febfce492401c248bf7a49..8bf9f099e81b3263072d0e86673d7e58ac3edc7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae450836fd5195171eaee1acec892b9be57e8a19..89315fe5a0dd7cedd0ae22e4a17b819955346a7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b887e59728ab3960b056aa264b442231c21b5ac..6ac3dace1a0ffe840a9d0a5ffbc38967ccc4ce68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 708dae543744279d62344533dde96d6af51a2798..72edad087c2b34a73a87c60afe0a70387480d814 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 368d44f20103ea93ee491d2227a04e17a40423a3..1c5f00c3676919f713b1f6c9a258b9076fc0bbf4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cf5cac4629f0cd09bd5cd3dbcafa38c2169a13b..d9bf4c8f889e391dbbf334452e399fb2e6fd5bb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d22e6df03ccad2291375348bb4e93ed04f630c0c..9906eb6298398844a921cde85d3a93228a13add7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a463111aac37b8758976c570c236d403d03c9f02..d425d2cb75697115bb7ea8a549fd88a68c074a93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 693afb6a2c24390ecbcda8cdc9739ff70468842c..b82a1cf4cd31ad54840c3adce718b4a656dda3ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 884ea7702d4c5e65a208b78bcf0daaf3e8220662..0ecd67a6124954d511ee79d472bac65a519b79c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a6a9a7e8947c543bd870751ee41378869262055..aa7bbec57bcc514b470293f2c8e5327796767ce5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dbd5d962ef14b3ed0c2d92220610dad75b9e292..aac8e99a44931a177539601eadbdbfe58285d7ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c577ba47570218094ee8a87cb8b4057d926fe83..e2f54dee64cbca61b92858cb9a11aab30298a4d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bffa3a052d0ecdc42037e9725e70174b8b7167fb..a510113d2fccf8bd57300b488e2fe387c6d44752 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b973251d22c2b0ec5c6461e99db8e80867ae8d93..72ebaaab5ab63b60199a32718134f3f33e6684a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d583b5d037bdbe7c663448e41c48f2151c9e3a9..7d863bda04a73901731f8c534490029d70ebeb5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76cbfe9052b855c720d60603902d129c64ca26fa..452b1fe981dcb05a5f6eecce6a557a36a8eac6a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d65ee6c2bef62c332226dec38a62192be235566c..5ccb9f8a860753858992611953877e7bcec290b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fa9bb0d8a54f1d54d43ec76394b8f9a8daaabeb..89d7bec768649fd65bf870956e400ad7dcc92d9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d006cd4e6933bbb75c8f62c61db4bf810fe9fac..81ac207056b0a4fc538092a028000cd832486486 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fad9b1af6e356c0f1db59d102d74aef554852893..5cf6319c6f342b3510309a94292e330acbe96f87 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9828bcf1a34db2a9c005ab85b7fb58eb9bc1bd1..b316b90c6b3f68b5e4cb629b29b8721b9c228ee4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5f987f69d954d204f9de05d549d5f2f8d54b301..231ed5eb5c7ed974020dc4bfc66c5d15ddda0f7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 995b420733e004c3cd574bf3fd909c187986bab7..e0af26c288114f582b6ae72ef4a6e9f3260603aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6d5b007ba43463c2810819a237977c2d47211bb..966424a089e0f6979656accf0d35dbbb4dd278c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2edac3c62c7f9884bd7dfd78d59ff5c504d1a5ed..659fdec807bfca9f34c92bbcda74cf70ebde43ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99eece721744735bac1e3dacc2043f3c43d16216..7c36442760164576fb2ce0c9120d3a354dcaf10f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3802fc0b09c2945ee8618030cf1ef741dbad931..2584a59f538c2109c626a6cb1879e31882d65bae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e901f6943104c44b6665c67ffa77278938d3cd6b..f2b8281eb529c3e1b2b22db2a9f5ab0be295fca1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9acb11c1f56ce1abbc0f9cdb2ad973558ccbb2a2..0d4119d670bbf8191caed966ea866c188ded220d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d4356732e9884a6e3c6f54182861d074d890de6..374af88861fd5f8fdd232abf8ce311c3212f838f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5be3807435e81c985ff2d3971ef39dcc1a04bd1..7519a34d0c7fc7a21fd68ea4f0c5600ca183f489 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc9ff4526ed3c7ebf45ffb0550a504075d410663..b51acf8acc7a2195a66c52005ddfb58595b79cd4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91980c5f16df64fef663bc06f88f170ac179bdca..edf393eae4f75e946d5b02010c1cdf7cc13e77ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36d34adf37e6aa0db4f03840a048ea03ffa27e85..f7fb245d833cc289010ea963388d0219e543bb6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c627383710aa3462ed82a46f34c72f80c734cf48..06fe50376079e4708e1de1e71e09b9b9ce456f94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da98db1496ddf7e6ccb0a855710635bbec259f36..465a28358d6b6a8dc50949f1f5d0af54b8924da4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c1f6f713a0c1436db12b9430f3cff24673fac55..086c9c54fd0eeb91515381501ed47a69bf41de30 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a20a47e8aff48b3f8d8b20daaefb360b2b04325..d10cbbb5d9fbe1a216a9afc0fbdb4263b4f2340c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ec2c0da745b6a8236f17236ac7d0c8de19e19eb..b145fbbf9babd7c9db9408201aedb26a99ce00cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e28cf0f520597ed202ae55f4f58fd466a07cbf43..e39a6fa1142389f459aaa7be9a4c05cc65940ff4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2140024c5a42eb1038e274299d9133f382da8a77..6433e5aeeb8e523e879aba459565059f08030c89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8464532df8062808e7c8a6143c27c18a4af137e..7279b3e89951dcd064f565fb2ca8df43796d772f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84aa7f3a3034c6bf3eb80bb30d8fb53079db5618..4c714adf52a8b5078bb3182d64d47d5cb41388de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd82e269edcc166a5dd11901e334a281371a5456..6cbff6e81e15db8eb1041e4f2c35c05e82b3cfa7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09cb08577542d65f221bc7333724faa623454d28..7f216cf2a8a8e004446fc4121b25fd3b0808ebf5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1f1fc0dc8fb02a91711996fd5e4df4128403632..16bbb8ef5c2de124b9d52ec9cca0ad3b32ec52f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a52bc006e02a3fb2344e5c1da0aa3f9c469ad362..06a8c67d0bd18fa66033a88d9854b1fd60bbdbab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1159a4dbb40070b21f57d583a68573f50cea10b6..3ee00b15324acafe7a7801ba138191c213441ed0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccdde1d1b4766644ad6380dc0c3e88e727ad19ab..9f35e684138bfe446741763f4069dde5ca807045 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 754dbe2565ce0f9a3204144f231ac3e30e79c17c..e0251d34ca1986c23c73ee0595f5e139ddf71ba4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9649c3da03b1aaa60bf592a3bab38fb8f2797a61..f3de130014e6477a47825ecf794a57dfbdbe4208 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c266c14a162a68c56a9ad17b4f46da7869c306a..a4b772c1aca4f06e49f720c001f75cd719d8fc8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e7f8b184f0715896af5803e72699101f56eb97d..5d23b527dc99a5cfb3897bad0a66416f2b1d1466 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b827d686248c305e27fb299cba526ae47b25f6a5..c123a67bc03592c3ed6380a417f3969111f36351 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54b7a24850907d777d40c539c9caa59a405a4e68..a88e363e38db075fd3ee29028ed8dca83f4528d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2762681613ad412dc2d8149c5b8e7bdc37044382..3e73ea57af2778ecdb9358211dcfb38dd3a574b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f85cffe76b6f369f756595536e08f3000e9db583..ab7b89562c46f1ab3df63110c6382c5560b3ff8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c58a72cd2b039877ff007b6f9a21854385faa45..7ee39129298a92571bdcc8a442a03866fd12056a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f98a3ef7c79c08683b7c629152511cc6aa9fb011..b27498f8e08a4389dbcf261b14444e2ee3f4ee4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab8b1e6e6c9c68cb05bdcb24183168bd4d920a94..ddf7506b526d9f1b138fb6e70cec39d431d3654c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index deab8fda172d0e2a39b7d2f97714c2ba07f63ee5..8db5c28ecaa7291c6e3e1b2bea3ddc0f7ae17654 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36c298ab5516275f07372b2cd278780cda7cfb8b..0660b9b393c746c5d8244940b8b1895e956ebe02 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08e5354c7f849c09c99d4ef27e80c4fb282f1c29..532028ebacbdd65765684740208fd947ae198bc3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1487b76e7e4717f5b3bce361928f26ac45fac981..4245344ec3c63508c6cfd3a7caadd9d88d62e41c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45a8ebd722437ef4ae805fba945120f3d3e617ae..147dbbf0b916e2a4c05a7a3905cb7d994b80bace 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f5c74e169d845a736057a1c9dd9e3af819e7a87..c3248480fa2c804966ed7235e4591898a2047936 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6b817236e8ef21a8839cae3ea2599dc2c6750fd..11b2f82074767726a3dd7df0582090fbcfbe2c1e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30915ad71f1002761f0481224d7bec48a5af630e..9e43bdef305c1bcfccc2a1a2209379f2b5a60e5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1eefb0195f5397595a850b480781e9f9523b365f..2e08d99dd704fc537924c9c6e70cbfdc8138e50d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50738c5bcf791128d2db599eba1b319cbe6617e4..00b6f5f9868cfeecd5dea84cdcb499b117ae3d89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e5cef891545249d2913e86e62ab1cc1a8679f6d..303dcc31bb505b69809ce59423783f839f07b944 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80b0eb293898d7cd5c5fe51d593727064a6f013c..a74466fd59e22e88f91dc830f5350580b6a139cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef9967e8f16374f2546197013d1554cbd2fb3ea1..1f1e0e011d892f65c6e44886993541c5db06c029 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c9912f90a7e66d84882507f082b363a0d16ac6a..0782780f664215cc02c41aecf30288c0f698e698 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 655963a71cabf82be09d2e3ab23edeb68c856c55..82965b6ad0097816158b8aa23d827009786614eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99155ce7dd5bb0afd44addcd37e5759e317741dd..b9f73e6f2c56e8057a402f44136511c155a541b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7938abe630e85352189278be593a75838a638e57..811cec80f28b7b491710d29229421c8d4e5ce35f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa7d6cab80a2d3fbfdbfa8e4089fdb9852f2ddd7..ff62ac369744fb890bf89c689c7c34bfe94e7ac3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5b85fa900a55d09ca81bccd6d26fb6ba533f85f..9c12bb670628e61bca66dc08466017fc7892585e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc05349ba084cfaebfd0364881db352e17dae078..8be1955c100dc43dcf9b425cb13665ad7a751c20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2845008c98a0b6e3893ac898e120b5484fc9704d..9b07985ff53d6d5e0722736dddc47381cfe524f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4462dfa5a9e14bf4a4addc5e84941dbedb74055..9fc60474b31e769c7f29e2cf33ebdc2bfa64ba7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71017cd38120be5d39cec47493816e4598315d52..64850b4b9c575d7b1e17c6468206542ca7c286a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6913d1b14338f1723316660d255d150148c34b3..37abfd48bfd8d2c4a083fcee9fd6002448055078 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b237413d594ded3695cc89d3cf27c9c5ac4b4cf..d647785ba5b21a83edccb5ce97279fb6e68881e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87d36dc77f6cde3d3fd57b79f79065747698484a..21b0797eec78df65cc8ecfe41f682a96d07b545e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6473abf7f1397e9ba1660b4c893f0e33d96f262..5a24d1d79208609267d2ce2b1c891fd594667337 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f2c43ffa47b00717e0b7550345fc8a40ac17006..3d3209215713c10c8755f97ab4b86f9188c7dac7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5703fe2dbf0810a9bbe221b0382968df8caae33..707aaee836d18a743a6029075a37da5510dc7d53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db9d980ab6a4e8549d6e21fa16c71d8760ed18dd..45a082ca60c5580f9d3f593c80a88667c297cc3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59a2b222af6fc9fa32ed20ea9bf65363746879a6..0cc70115ca0fe97b95c9abf83bcb905f8e75bb70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23dbf19461ea4bde353597a8bfde9789cdda1b9c..1ac6e594d3274f89dc890d5d885fac54f8e2d34b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fb6f5da668098b6fb030df1025fc0f63315dadb..b01fdd4b96f75738a7c74c9057d7866475696425 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b85864e41eca37976828c9c9c3d09913956d06d3..33c17b041007d5bcc0512a3c0e05c54a68ff0d2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ff35c07228ef388c6229f0c31ff2219034ecbfc..6674e38d28c9b95df815ce78247e07b8b6dab22e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 243f2f7e8b5defd46d97c46813e2a132d9b7242f..bce36559e5f2e0da673bc305fc8d31dc518e89c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc71649a9704ca2b318d0534fd5e379d1ab7c130..b1f2e0ba1579c2b732bb5d399a1e112414f72fdc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a58b67a82e51d45c71e52d9b934e0d97cc0fce79..d4f7524acc657a0a8065d77ac8b9cb9685a945ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5cbf4e5b96ed4f21ff37f008574ee169225e52fe..b688a276749d4bb5becbfcaff1c9c626ba6ba727 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b21bf8697cc6776d5e9b7f30a8099b8259fa92a8..ed17cb9db717c42439362d79339bbbb505503bd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7ebf647767ff1be5d86bb57b9991e5edd40261d..79705077cc40b5225ed0b402e55ee11bcbb6e830 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9033e7bfb3d3d15ecb5680822320b2c9ba58615a..ed11ee15545a2c6824f1ee9a74fa5d31c2d57544 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10ab839599755206aa46c2ae627b20ca6b4ef83e..ad00f7cfdfe8df7d71fae013f039d1183a5c2684 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b47bd21a360958b14cabc9cfeac50c66a547e8dd..642eba05e621a533ec7b52dbaba6ed1fb656426a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da6c91a6291c9ee2e3fe0b2546d458803e70559d..240dbe835128335d23ba8ce3ce397a5a73887b25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 048edad899e6b9c89fa9c228213cb9a5a63de67b..595ca6502457df7b8b1274810c3f94163cf2eef6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9de8461c926532be25406f5ea28083799dedbb8e..8598d1349b76e84808b9c570dc6f82ed1da3a1eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 295f715105f98ce131437c8d12baa0a2af32ed6f..bab667a1c3880a36dee9e1bab608de9e11c585b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 673fb89d419d193d5c800c58feca7a4929efec48..13318e7254601c3dac8af5727329c20da7de590b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6c213f267bac3acfa458c9d4e484aedcbc1b697..f2439c1df4223b15ad472a02de53e7e8737e2135 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bd387d7ae8def0eaf106f7a76d1f70df1423eed..460537aadbf7600fe861b29c8937852f30f18b52 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5227ab21fc225dc385a41002d9401d0efb2f9f3..a8604dccb9eec6ef08173cfb7054d726cc9bb3bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 732e7900070803d37a236bc06cdfa42f30af557b..8484ac00cb09712234ef0bb2b5d775d9bedec28d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e433c9a71c667dd6d32b1e2972b8a790cd48b99..085d9d2556b65ee09e7f12c900af151f210d1489 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4886f95ba605332143363f0783c2b150fe4555c5..e26ce37a61bf3eb1437d47403597eecce177822d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a21867b7221af690f819199c64103b15841b99ca..91845f6cead56720e774b0155119312fc1dbd227 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3273360d08e318f2397f84512a59c32ea2d913c..ee7ccd75ddcfe766f14593bb89a8c96db6a22953 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38b26a902f2a1879a74377e1ba78c0e225a417cc..dfcf40229f578d633a864bf388d33776a680ea03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f333ac86702b1639cd3fadfb0bbac1603d028d04..0f318fc8d8fa86d22ca880cc9ef4d05fac997d07 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d5336dc417d3876052f3bd0ef0f04b83cb12d84..e4ba0661742d274b76e1681b9d03e4c4423434df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c5050c9987ee2b094678c29b71d83efb56c55ce..7a938399a8cf4c8febe56b32da62c931fdf4bdf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e15070979b0081fa7519ccdcf363e003ff50b7c..bc0d4b18dfd2993430df7e05ee272f3a43d295a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d520c0f06115ad4bb1830516d305eea2102de00..8a2eab016af69e5605fd686d06a3a151dbc5cf16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efe6ca9829b8f282f87d52252d133f65eb4dd1da..c051826832e4a486b8e29e08a5f500775d3ae8be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa3a75aedfe709b9b640d8f5dac1623e1fbd35b4..7b917ff9c38366c45d99d4dff755fac2c613129d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd969ef9840734b712e1193362b7a68065b43a6e..c7ebbdf9e935b5e8adc05bbe6e828c3456d2a8bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 556e1adb74bdda113673c752c429b26223cadee7..b5d70bb7680634b5910239fdbea041fa997aad84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8df04f271ad6af63c46d0447ddff3026cb5933d..c45ffd612189193edff9c35b634a4cd7d2aa1d60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08723bef76d90e271fb64a07ece91ee5d1b5e7ca..6679585a34282083e3ff5585a7c365bb85895728 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 15f5b0e2914ecdf753d34bb0908302cac10623ea..75a28ef6850ab57e0bb1e651afdf9408906748b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0c10f164702b4b5f9466c886e8c63206a06a231..abab5166cf614a1e6cc66e9f1df2ba70463d6a85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c51c9bdd7c075b2879df46b4e93f4b936393fa0f..67f53fe2d5345829f7e3e178e9317cef6574c7a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 958faa14fdce3d2a8206e7acd85de7950f4a8c3c..0cedf9cbb12e2cff063be23e22c160a564e8e457 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4977a610a25efd877c7001c8e991266a043e638a..398d26f981ef78e7c59c2f4784b6a13f0bdb684e 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2015 by the deal.II authors
+ * Copyright (C) 2008 - 2016 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 142db49d6c59b8042a1097cfac7bba53dd359969..68e3dd190312654980e2d1119eef0dd236f90230 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 398679bd3ec998842984edbf2983d605f108f7c0..eb64b524f0b9c91e361b208361c1f40e54273b20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f9bd23c665b652407d792b126587bdd33820b3c..12a458664d56ec3033ff2bc9a3daed4b21492d69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 420a2f47fe28b67ea001c0d1a10ac6378c1f1476..1a8f9114a2a6f6a1d240993e7fcd111ceb53a971 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a8faade936517118c27ba7a7332acc0ede6fcac..5b5d95eb31879a8e8a67097e247fb9b29e1b82eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7e09eae383659b20cdb14c7843ad9fa0c08f0ca..c7e33e8c37d787b7d8deea35aacc0cc20901034b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93b247c3047fac5746e15ae3133c64a05d895dfc..b139c476fb57f6103e255e71176296227893554d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0545879321cb99c9f4f2f6089ba65ff54597a3d5..887cc79f4d85c2d59a2a7fc265febf418fc72c26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 737f93afdf3951a77a86edc94281e60ea5dcce85..a7a616fa3f4c1194449155d56e40b103eac8e3ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 377dde448d73b5cef12b725367627e41c5fb9432..8f523a531db1efa114858d5ce8c970709547eaee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c53d53dd7ec74d452367ca00df7b96c72a25e3cc..f9bc602ee2e936976755827ce4198b2bbb740cd6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b1edd6673358320b27cf5c936a75df8a4fceece..db2489fe3c4c55144fc834d27a3ec3a54f99f45e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 748afc68e157ed95821295b0489e166bc8cc0970..3d6bf48c13a7815889697e5f27f81c38ef103c17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28ee8d76a2717ce250f390dc8cde5d80862d3680..59e89065f196de76f8160c98c2b1170365d0e10f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 359a8ab28f7f26fca62cb95ee7af5cfe16eeca3e..d409c247e11dc9c15176a5562ef9809d0f7246f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77f0b1f4d75fdac71f014126c7ed55793f1acd97..0f22b8ce81a80a76777d8ddeb0723f0481dc8b8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 276dac797ee2070266db9193e738a116df161984..96f4b2c8b6704a3c16ed74eba65150d479202e8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f79b2d0b993035b88c9f8eb9f85b1d9a66b74297..82b4a2536d8354d21b3a5980a04cd92b3087b3cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f5947cf09197e7c076c1ba6ada7bf69018a7795..3e8cba0193d8ffac6e55f5b677060c47cade1ee4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d194b304b60a254740a83b1abb1ace8d7416b61d..b5b9fb66f64288524505a9e23f310b0a05a5275e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fdce8c9a479315d1b4198bb260e2a6ac440bc727..f7b7b01b88e175d860a2bbc5d6b70039e7807bab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7538eed876d9097e344d189dc387c575f24c038..b3ab8ea87dcdfd09ab868dfac43b5cc23f78b598 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7aba6debed0485415c68b21ceaa896d001b5f57b..16522c56905b2316d973a070cb022a44a8493e70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21838166d9196f87d761d9fc5735456843d2066e..a965fbe4d616bb7cd4ad6e53fb95217d44f7a759 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ecc70f6d7eee7aac58b0734ff5d09a095ffdd399..fb00d8bb8bb6b99d6782fda30c5896a4c72d4cbb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 144316df6a4c19979cb4b9001a682c58bb2ea925..a40fd2dbceb7b5518735db37ebc17680d065fcd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ef704c43757dbbfb9ba728107d8f5caf124abb3..aa3377d1e0e2effef14f473dd1487d52aa9f4f1e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6a56dc74a9c31c47ef8f6cc8b4866790c9b9d28..33e7a52ee193374ae45e887953af5de7d77af133 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c487f4b3d05def82dffb4edcfe126079c3c90ef1..da2b218331ccf38041368627df3fa24876579a91 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a202aca01eb137174d2126d3d08f8b5665f3355..0b9fd7c6dac8ad126815ac6daaa95e2e8475d462 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8cf6b0341bbbf7108cf699fb003b1c1889f76e55..79bbfedc588177521b806bc3c3e9cbcc737950d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e50b7fede1d3a895d14703799cecda6d3f9ef8ff..e186fecf169da7831d838f2e3604250cc0b90317 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21dc9656c9c71a5c1935f618981a0a43d5305b3a..cb47beaa2375767a65cb9ca378ea590bd5ae238d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f9a8eda8ba0780d2cf8dc7a753fde13122fca28..e8b90ceb670c715765a21fe2f93070c34a5d9ee7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c13fb4e752e440d367020eefe2af988e9616467..83a8322ddb8af9eab56a1e70de776f299fd56831 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff49219669e20f11ec10a9f6f47d68c89a1e8230..51239892d4f598b579cea82c7dcfa724ce5903d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7db838129665915e0d63b73178a04903948c450..d39102a59858825547425b1dbe2ee0034408cf0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9446bf2d0fbdd395f12f598462954465f0aed7db..8e3caee98098583c785768eaa2018260cbe764a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0039523bccc182da780d6018f7a475f88338776c..a75528d398a31f2b9e59a1e788094503dfb1f1e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d74a0407fc97f8e84111ab46a0e41eae5571a621..8aff3b8429e1e7ff31f16bb0d9826043a0e1f608 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b92979b03b9e53b4f2d9f8642b29fc5afac50f6c..490fa6a544ee094bb145b41a7e5b94760182b184 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 096b0d2582304c366783125538b2d00a34b1886b..842cfe824d0ef6871e6f2acc9cff866f30a460b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a14c4167ff5e0d020ddfad34777d955dc9bd97ca..4963a1fbe7280021e715630e581cb077dc5d74ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68e99fb68cfbdbc3ff1ba49faf6bdae9ff6879dc..38f07b2bb7c61f2d7840e0b20ae7e3ddf0f6d131 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 414d283a5fc1ca7296bb142531df6cd7e29c4089..00188ee092785e0a508d51bd8e47c53d0e7fab78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e289034e609894f79e027d3a1a000843abe57235..dc459f1bf93ab74a52bc0c2721329fc0acbd27ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b27b0d6ab726911f4adff670b29b2634e7cbadbd..e81f4932c44a4000d5bfa8addf007c23298a4d9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2946440fcf4f6706d8d12780e79ccfdda435970b..aa1d3d134324ae8ba282d73c371468f5cc622834 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a066485f37f436302f9aa684568c8a751c67ff28..d6f6af66addcca4ee1e97ff24a517ad8d8020a34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20be83ce05609446322216f2432a30cfc863db9f..6d17d3e1924875e8c9238cc77fbe6d54f08ee643 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a172728bbd76fa47c59de77e9ba3c881cb492e43..e3ea3e7ffdaa936d997ac6b8c4f8a7d187a5164f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d62159be6ce9ccf6ad88813d031c21a24f19b765..5428569086f3534c9b9b6808cfbf7d3faa8faab2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e683d919c446dc84e95e93fa1152a0db2bdd6817..991d6b7c1339af9bd9fa8e55a75d4bdef06e4db9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3b3a52a3c8d21ee22a753aca7314cd5ec4d4617..f5aa879828cea1d1649d7985558b07e4fc12cfc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54a79eaab7b7290e4d3ed8a45b69763a927418f9..71803323574e17178a146f549cf7118f9253e4ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe42160adf4dea991ef20095c34110e42bc37e10..33c98db4810ecd9fe917bc7bc05da6e7a6c71cd4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e32694ee5e6cc9fb0c097b33770e07133f564a80..6bd77e49d816830da9cd7921ac977c5c8efedaa7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dde81efda71bc11e511950efa8cc9d105eed5b06..c4b880a89623964f52ec9cac1fd16f98bf9fdba8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff27d9f9cec46a8a0670d660867a509f1b392fe2..5724321fab06ea46527d54239a9231a6df0ec693 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2d9f2ad423acdb3390c8d919178fa81bf182e88..6ea1ed12a503b8cf644a6882f7ef3f54ec415cfd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77663cd6882e841dc89fa0794e106dfcaaa65273..23b5c5dae833b2fa8cdb917ba17ac8ad96a42572 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e47cfc648968ef3ae046d3b05984c3c7c958ecc..1c8b9c833980c0d7eeaf67a00ee7139d36ee7d78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9611786e83fcced182e3d1132b0d2f57ece371a..a03b9ee7984f6c2a0dc66c164de8b5f050490d21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08ea2d414de06e864c974aecbd07a6506e3c0ed6..d0232715852d22a3383b71913dafc476dbd6c18f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 581008f1cb38c4fcc2daeea190b7c46f97f01d73..f7ef39899b474c93b39de5a8e11648366eeb7e8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26d463cf706ed42363557db6d0ad570e0912300d..d39d4c5642845b6013e2b5bf1535add207b46405 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93f19b93fbdfbcb2a8297a92ef9150a34583a0f9..00444f80befaa55232cef8215aa90e69f7d77e82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af6f2a3b402700047308cdf2a05a5034851d5b77..9abff7aa8ead8f5d9adfef7127bf7cff77c64c39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95d258d75222cde532cbdcfab0c81771a535fb71..516348f087eac7efbc2dff9af4a3bc33a3ed9796 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33e22457962623aea47437d5af062944a3caf1d6..b1df4522a764fc68591ed523d47ecc4acf877cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 488ea3cbf21acbcdc11e39d9b0821ae5d924450c..377fa92907fbb85a57b6f63a1f9c91715c46e8a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb2c6919292dbe6f802272d0fc602043e83e3d73..5c2154f55a0b8b5709b248653a1b9a7986946c38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77ecc46720f08182f9ddd5da373f99d68ef3958f..4f333ae861f54156f6e52e42ca0935083bd82166 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a8b3c292134ec8e8afb171401c1847857dc2c7c..7f1ae53638d995875d6f4701f8bf56d206106cfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d927ae484746529ffb5786b79b5c5fee56f2958a..7697a797246492179fda43627fe8567ab38ec009 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5ab0e065b0662f3221fdcb5d4bf7c38d5de6b9a..072c6940af5e5d57a5b3bee65354745a37e83f8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11efbf386391254e030caff6f0b4d3019c193fca..df50452263d1b8d089552840e8576815fb60f0dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae5b68a9c05de5668e2f792bad601d81bd0e4df0..b86f057fc7c8480424365712cb2c5d0701d4830d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 309bd203d898103c1a400273e3be5a8ad08d4847..d23672facbfad3fbf96326bfede39edbd942bdd8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c37352d1e35c25e89033007692a5033161bdd3c0..ce00f04911964de50cffb731634f89a4cf15ff60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 811d030f733305aa35225f119e27918012093e41..ad5bd8ed6dcd3bbe1cefe546268fe31108d32949 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index daae99c8c69ec4a8a8cdca4286df2991bffc456d..af5b9a25b2736a2e264246446eca748497d3bbb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 493f217720425da54c26db5d769249934ad5058c..516a5ff45eeaa22163f4d2b4f6c0453224cd5dc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0b01308df66a353da5fe4bf31481c4d0e71decc..217d93e76e90562947e675ad43cb074356f8a252 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e5d515318eaf60f87e3fa8a5af226f382f20369..731057f8b62cc6b3873587f0a87e58821be0aa7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f67b85d0f67f8876da186231c998510fe3ea86d7..d2bcffb21f0c9140e4ae544d6bcf330504e52f10 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 683a030cc4d664233c43e4b1782a018eb0134173..cf99bdc753eb81c135622f315a3826bbc35c4a41 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a0e59cf87d72a09f4f959574092f7743064d2b9..f8c98b9bcd3dc3d18f6a047cca8e7141e1a278e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4d7256bf94b13e14ec6c9102a6da4f9894a7028..c3b80036ea05f8eba10997f1dfec1ff64ea26d57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 682d0cd2114b6443f9bb526833453679b16ceb0d..dbfc93ecdd0a771f960a14364ae2aece951827ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a5434a73c94edbec78f78a66e528ab988b26b37..ee6d2f69851e35f429fbc772767f42ef90b3d031 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4b7c5997770718017943cd3f5c56b7aadec2196..8b70abe32b4107c4cb344efa495a87c005437b61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2015 by the deal.II authors
+// Copyright (C) 2014 - 2016-2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c73835de6d6ba9c9bbd0150e01add50b8f37b1fd..c71f490db8b168c1761487c71044a9fed381560f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2015 by the deal.II authors
+// Copyright (C) 2014 - 2016-2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d9592d9f74b56c93932c32ecc30989f43e1ad75..10e5099e66ec15f1ebfe4bbaf004e3e59dd38c44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2016 by the deal.II authors
+// Copyright (C) 2014 - 2016-2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81fdb30f0cbc9edd038dc659a5c0cbf9f41a55a8..1674f7c430ceaa0aaa72a86be5aaf6dfefdaa796 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2016 by the deal.II authors
+// Copyright (C) 2014 - 2016-2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7fb25431aa4c98d206bb2afb2b418adf309df88..c8a80110800f741682907fb2692efc250fdbfb98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cdac3af8422240f029dc6b9fc6405b447a4bd5ca..99f46480a407459f3f18ab41ae8d040b2ababecf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4182008864025c22944a4b7a73805142f7aeddf9..b04c47e4f15795cdf2cdb26090e94e061ce4119b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014-2014 by the deal.II authors
+// Copyright (C) 2013 - 2015-2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff3dd4b98ed5a28cf564711d31059ffab1f63c27..feb4e272101794425914f378df126fcdd0351ba4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014-2014 by the deal.II authors
+// Copyright (C) 2013 - 2015-2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df67a0a92604e6046b262229239796ebd8b3b652..1472c1ce086f84bc71c617833515da18c1c19fa9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f459a48b54e8e81892851b9a4b990dcf2c78bec3..1185eced40847b498a598dc3ddeb0cd823520fd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebb7592e8f9fcddabef879b80633b3cccdce2480..664f2e2194ecc43bbef09c728bb6368ea8e6a384 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e62e9a51a5ea1ba2e7505305ceee2cefbf4cd5ba..eb99694866dd81e65c48daa49225d7d342ab7d10 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84e54159cc2296d8ca63f58182f7404243064cfe..6e3390e52419cd6ecdf09c99c9c14f1cd0dd89d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f953493efb8edd311bc9ba5a24ce1a4fb12567d6..30b4780a438acb82184f68c5838d6bd9f552d39f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77bed69e1749f67f819fed24066dcea43636efff..65a080b1c69f67ac0a6d4c92f68b1d3c748e5ea3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 054d9fb69ac3cb4ce05148687729f5d888ce6e10..fa7e6a41736f5070caaf4933ea7f65ae6ed6ea41 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7cb69477cf3d360af8893831e2b921e42a96b61..b013aa70f46047507b55b4ac0409c13348abb597 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00bc024316b0809ec8b4139202004f36abaea7e0..61888f2355ddec3210545c3f75955de78015bc1f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b1b42b86a9685aa0460049fc4ae108d282ed2e4..333b61aca0584eb9c00e5350e9cde0551f629573 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f1b6e2b77f8e0079d2954da9cb93916e1b73d62..1d69296cc79aa3bb4fdfde9f0872f0c0efcb448f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c84b8c8fddaf50f8aecc45410abff29f3f41a7a7..0118d4bce3a96fa3c81f71f5fad961918c74ba2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf89e220706669fc9392470f300ae6d5d29a5c7d..ab555165c69e0eb887c7da4d76dc8b39182a92be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75620d567c564a5d70db4ce16b22c66f780bbc4b..ddc9d7962b79ef0c8123903734f0cdb4f3df401e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c297b685788cb86e1133a4091220191e471ccfa4..f4a1bce4a9b05665459cdfe42b27fc44a56d2e31 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e6ab694b2c4cac6839b279aad1d74ecdeba70ad..f57cff9d162f1dde21be7490b844e1c669de88c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fe15b28e9e12a05c03b60359ae88818decf6597..443eb527c37906afb20742673c598f728c075cdb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e240e02cb8b1b23fcd3eb688eecb223186255c08..c3797744769e25cd5bbadd315c0db5f8064d1fc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8950887f5e000db6bd547155e2441b7fbc84cf41..ba1a4e69632bcfdfd9790ace133390133e68bf06 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40776b37cb17a6a37019fc34eb430ed091b54486..550b7183a6d085da5cc9b9a9ca94863c4d1b0a54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e94c57c4483a3ce9ce3a69a19fb6f7273d53b1e..5960319450546fef1451de4c558d627ff7aed4dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d96f8f17212d2ff1462c02410a683197fd2d651a..24d8fbe834de7c3f93df6a36dd7ba204eec6cbb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03a3ad8a61304a1e46507460f78768fc1e6cf0f5..ca08fc49cb729a613ce0f828211598a4e263d9d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 276d2824dbcb97a526c3ce6d8491431638db16b8..c82ab4b4b10adcc921434853b6019769691005d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f802386f76fe01fb7b9384b46ed9a68d88b0f26b..9539e6ea1217154be6f3c7ea658cd822990b92b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e46995e92701aa0bf8a45797e2c640ed69fff7a2..b6d3101573aab6af1ab7a165fe0a8163f6abe898 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e87cd58aeb03b87e475750710967fd632d00272d..47853bf769bdacb1b068e4c2740f3f5b9978715e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa2b8364d2ce1cf8f5aaf529f5e4e35327d4d87c..5706af46dc487e5137551149947af9cea6543da5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f1fee866f2a51add344cbe5b11d47cfc039b636..a181c25df9ba2ebcf4c73812a0a0f71a8c201cb8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f78558101c8ec6161edf0665cf98d7a01055933..ce95fec91e1f533f7d1e78d8ecb9cd964d4486c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31b132028b914bf0364a642af648b0ed0885b9fe..7bb7495ee7011eeb106236cee59482f9d21355d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2023f82e249d6efda97559b5821f6f2ae819e3bf..9a11c594e20aade062870d71d845b21c1f675110 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 238f7d5bf7aa9188f48c9e2c76b17d37396a2d1a..2fca62a3d2fdc8c6d4fe8252f7133bb598e7d3b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a0d4a8d135f90c4a059e625059ea634e3159a83..18b365087891dcf744a65bebe160b17ff4746dc8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d11b161d5b8ec911538c9c1390aaea79c88f19ad..865f234f96a79176bea96d6368a1a3fd53ceeaa4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9545bbe03deb677a966764cb63baa08e62213eec..68552b35d1de1689574081f9c1b247451d3b7bf7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a5e36dbe6f58865876a53f589a36e80317aa50a..59c2d643b0f8e12dea2df92047648ddae9419748 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25494ac4603b248cb3cfbe164d130230e933258e..ceb8ba4643c51a18a0ce5745175fafabb81c4505 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea25bd7c56f70bab7576429950ca83470682fad8..234441b5d9fff1d97c099f2d9e8011b0781d93e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 788819992124ed3c65355987393a4f2baa58c6b9..b10a2a01e845a46cbb72940df2b5eb2bfbf92fd7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7efc256db51f69b56fc35f56ea33e13276fb8f9..9b9de080269e570bd7597fd82d1c5940a6d0c635 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3878c1feae90887b2be1ea2f250827ca1fdf43a1..5e81442b84e40cb614d1d828a2df04d613d78d9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e1490159ebaa41aa92a218b057cfbc01dc68e1e..1ebd5d7ed3c4c6d37350d9ce1ac4a0811cac2c71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45e1d089ab1c8954e81748c8404f1b76d1e966b9..511870a1a1b7e9146d483b84eed02626a00ca65e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6df26bfae464c0134f40cd18918889ead1f5593c..b140b3683da9fbc0cb4f64896b20b764818889f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7597d8c14e57cde0b410f77963f7224ced79b1a..8d17793dfb8f44a2c2e8f6b95b9cc87f880fc6db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 577b4fe86505901e4596865a997e3631f7c36e87..4584c0a3608fc6582879ddc734480e9c702af279 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 246dec1fd5b583d2e3fc71d03190209972a9296a..600260afa325ad4012fc225192da12fd946d51c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 398c191e87094a973c4e9209402c29df64bc0569..9277fb64fcc65f7e5a5e89d0eae3cc63b2e1a8da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cd71dbd4d759ed10bc613c751bf3d097fdb0b4d..1d912b5359aaa329e944a665c60e46833bac95c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e64d6831974aa9bda60f5f0cc4f2312fd1be84a7..578b1393013a15a1dfe4711fc1ab7e345a92f59f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bf7203dffeedd8ce2785323958df634ea983c35..f8183cd33b8b862a965649a0112578c839eeea40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9d48e57220ab85391db42f21d7c8f82390e1e6e..f972bacacaf7b0cb3e69389ca49ee6290989bee3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d844c011764ce0470a29247faec68d743dac3c9..b68feddd9a96b3322d4df668f7ebc9ae3a5b93c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 618f477cc0af8cd9e200fdfbbc9828e310cd274d..07e8bd93d0c9d6a14bce626d08bfdb0c70ea00f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f40556569ea0ee567b4a990f94d4434e6ce1a5a9..023dedf6b2957539995fc055a2fad78936cf6ac5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81ddb73fce8b2aaef6ee2f3db8790a202705469c..53559103d0d1a4bf2a01c5b9e42925b55cee427b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d68805db4e91bddfec10aeb847fc0862ba53d0cb..06ba12f0e231d4d210b1a3805e70d479a88c55a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d911ac280c926de97309a3d6275f7026c416b03..fbb4361aa8dc3a5d58a414a8d20f82ad37ca1ba4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46e581d4118e23c9a4476f7a6e16d012d0768741..dfe0ade4fca294c85d98fc47f628b62bbcb0617b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 536c4468aaa18ab3378289e5978afd87d8462abb..6db7f49388829b312cf2f834d12436ad9a0d9e32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c64715503aa1ef1091812a9882c4097be4e7b738..2a04b2c1c38d396717f3396a621aa2b4552b0e1e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7131460a465651b8e1927b8e4dd06157b8762049..b0a5811bd2fb5a1965f9064ddd3a052b395e9334 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a12ddba340860201247c2bd0334fadec093affe..534ab6a2bd9428db6aa0bc3896c3170e143aaa93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd6562b469a0094599164a3809504a48e63dcfc4..0a9bbcf287b25f0a0db5113d4334604f69430cfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c117b63ee98561b91bc4973cc7a66ecf4847a51c..e079db99527263c0f6b3496d78df796e80313f80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4f4eedc5693450a8579bd4673c34de18d3acde6..05770bbca1a1180e7b9ae538760d186727a68f41 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 907ad410c50f03014411e2e6637b475f1e406da4..d77b202357e2c3adc841ef6860dd5f1eff946259 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 132e33157dbdf3cbca3756e70b02475fc0bcd468..0ccaccd92a03f69b4d316c0485640d23ba095601 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d39f7e0c4ed5b5c3154da9e1a813ca8afd07a087..ce3f00f211df27bba9501cb1b7cb55f34f5a6822 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2014 by the deal.II authors
+ * Copyright (C) 2008 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index d8459540cb23b54293a4790544d977ea2d0c3b40..09258832e1b9cd5754f67f5c12d61d538d0af665 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 278b4b5e69a679d892468cf71c59de2438a1b3ab..e682835cf83a5a81f0a0de9037c8fa07c3a60596 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 159d907f0d2cd7a4f7bf8268016b2ed9a56d1b82..5b3315fc851de0842a5b6a5dd698d216ef7373dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c834b3e7f610639158a743ef3655fdd76db3733..ef0cffac42776a99522b43fac0599451c0faaaa0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3fdc4e3806d9e9b643e60759dbfdc78cd25afd1..512569507d8f86f54ec3895dbd9828030d17eeb1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76c7d00ed6f64ecbd4307ba6f106a2733a922eb0..4a318385c5d25526ac459ce10d14da29fd0dd473 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fad9121c91cce89b2ec8de7d2c457dae67f048aa..b018280bce505637c39211fc89c044e4bee8c88c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e3453f31f2d2b4affb881330ec8974c6d352224..434fc29f2904ef9b6bab69edb8b46c4c724767c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d9b7dae2809e323dc8ed9c32c522a5546ee205f..c3daacd0dd2cbabddae37b069a65c764cb83cb40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f2aeadbc41666398309cb9d2d12db3c3476467e..cd309c1a249ebf36e0a8db593d34c69d5fd17866 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 392f5307fb377dd12520e179393726b2a86e6a38..a28bd01b230400208ec6413b6a681282736517d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd6dece0dd020d3f3748e645aca070df0fc22105..2a6a115431766c0d4d19810483415d48348b2c5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 142e11ae69636603380f781aa6cff764a0ac9849..c559ac7a404ba1b0ea310f742bec52196fa9f6bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f45438f22f990c72f3c183b46ef655d6b4b26e46..71d15ec48cab2ca10a544fb2a883aca3fdc971dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f29def448026189ab97a34eba5f8538f2e7308b..c72a61c3eea64dc17fb0da29c1b57dd4adbe5aff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71e1d61e224190dfa727acd101fd62bfdd6f1c4e..79c9ecb28c8954910ce02b23722dcf1417d7d7f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6f2554b9dae09a84c085a956a17728c262458cd..47f31e9c77eed80fb003e9da15056ece486df12f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8df7357cc9723cac7b0fa6a3c8bbb7d0f8d204e3..0b425ae0f73ca3f92af59b7fc46a9532e19bde5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22e88e4cba210578cd5637c7b4b6291ba1ca58f1..4a651c5c2d5e7d6c48dfb99030210c03f2814077 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40e2fe88ace28fedac6cf8532793e15cfed32f7d..671b258ac868c8f015c00fb8075db9bd70e86b28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39dcfed0f2e3010a6558f192222fae070c2501cb..1a45cef1948867bc4a16c32f8eeae244d3da7aff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88d4c05813d3ec9db59498fe789044089bed6bc3..cf247e10dcdbb3752fd47c4f9bb25768832a2e92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f4d34548bda9972232e745aca82c16ce3a7df14..b59d9ef4aa27b02cea636355ce52db2a55a57ed4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5b51852a345a0e0fefaf0fca6bd96fc3d62e47d..d4bcc42a1bb81df843aaafa1b147b96385a00997 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 199e8d9c391d53607ef5c437f27c2e0e49fdcdbb..d6a636ec121941d6e24530df08f35b9786cd7f2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a66799f6c2dd7e6165a63b2f4452ae3f164c0bbc..005d41b98744f7d8827ef8e98312e44d72eb0632 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c522dfcbf8cb8d862398ec05ceb998f92cf0480d..e3aca49a1e1444a01a1922340a3d2f452177c4f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89e3e4dc5795beb2c2cdb334c0303d2b797c6555..11f2ef2b8ef4596f56ef9b92685051510e92246f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 318d08a3bd786b3c45b2febfce14fe1265b66982..d77aebf74fc6931e7603d7a9773f649e8a67448e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3876ebcbc7f10ff5c06ee474a70d0781c8261345..4d0e3987a4d18b069ba9aa1dc6c916d51fe0e448 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1675b82399e038c39e0620ea68a6c09bbbf249d6..29a8d26e1e8694fd3230e92281984ad2604486b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7573d269f06bb76a2d579d9832a898e39f21d98f..e0a0207fef9787fafa0e9908c8e6d665b0db3512 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9d556a4e2654f22b8054cc0a6f3550e9fc11f27..5a598139d8bc9ba0e91d6569e9cbd3ec38ede09c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95614abbbd6523258008e64843dffe7ba2ebde49..fd68e0b395051397323f1a2608e9577856dc7077 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19e41601ead332551c528d7060baa5cb4a173287..9c6bfc9d67575aaa1d8da2949c6039558beea94e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab77fbb5668b98c62909a09f25c4edfeb5804a3a..f441bc797c0e4a19cee74ab14434d8a9f86963c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 980ddac4f5de5f30e94620c08701a179b0d9cf26..e58521a3922e7245409a6be7a256dfcf3dbcf7a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97afc1e710be7ad273057ec6925f1ef31c2ff08b..8a0b229619627ea0754be28471957e340520b35d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60cd2c0e85bffcf02f698cdeb304c05b849e85ab..fff9f441af0bdf2815ac3e1257277b0fdc9d4547 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b069d84e42025bb935a7463e3ce94f6a914905ba..4c650194428c3b06d6c147abda601b38e3d77888 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35cf160bcd5e3248a85a2bb93887b3aa80af5d81..761e4214ac3db348af83290704a14faaaa60e433 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4147d5b3fb2e30fe146fc7722db7a319061491b7..8e4d0df46bc15ef8dc601fab85f0ceb54120bfaf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a1e401a89539eb99ab3d04698dc2ca2f39540a4..92d95195dfc3324eda78af30c42d93dcede75b58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e3772c3aca985470eee9b1dea9138785c032b1e..2c360dc693e38eef96c1688d19f64729500b5e59 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52415d8cb601b1991ba8246fcbf7db37abdacf75..8806a91ecc6d44d67d60a8b2d2f8b53392ce6077 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 055395f3efcbeb592891ec66a7d82722fc93b229..9a2f84f49477914719f380846b0da1d55c7cfd01 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18251f713998deb8c32673dce3c2a3938190ebcd..eb0d35ad8172a1c692eb16751a880e8ee27c0dc5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 903148f34ee8ecf627a011a5b8bf10c61c3ed01c..8f4b134ea961b79894925962ea388cd9db66ea15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d8abc01a01dce7b4b7aab8298b7598984ceabc9..bea8c7e501b30bd4418694160ab0a53e4d7f8b72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fb57eebc1a712d61a7033c4b7d7353df174c4c3..a1c6e5d50f399d49df146cc7c955bf6256783189 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14d0bc024c5d58d0bfe2b33a69208d3fa3476f83..adf29c3364f25182be942e2990f81a75091d8d3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0578d8f9ce5ec99def4e7ec2fdeadca337757303..e9bf4bdb3927f9f7a0c56ef9d279dca55af5a20c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01e5d867d05a50fc2179e4834eb5af4ea32e029f..404752835acf92ac57fa8c81ab555bb9b01b36b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2014 by the deal.II authors
+// Copyright (C) 2007 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffe62896cfaffedc8375e9528f5e791fefe9335b..999f4692641f5c9a02d9f040892936e08bfcb715 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bbfefe078993575fb0a9287139286c7b4bbd04c..0c20e0ff5825d8726c5f05316f3451789d4e0dcf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da877e1f17352fc1bc79d613658f18f2619ad050..e52ee80c6dab965396e4b1deae2118d00bfcfd8b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7972c775b4d8e49060e19295ccb3f6ef99fa032f..ac9394d0e540c82dbd17fd9723eb6619e7e80024 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9921a0772a0cf8724e70663cc2a313dee5a41ba0..fe4d34a70a1206b2937483859269c495b7b7ef60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 983ee5712821bdd13c6ada5b7162a485cfb671be..491803392d96b41c669fe8e664d0e0c3dcaa4e43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 158401ac9c19670b737cd0f054d7bed1d50e5eb0..3fc4b32cded514f071d2108b1d0b8f6d2172f4dd 100755 (executable)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------\r
 //\r
-// Copyright (C) 2014 by the Alexander Grayver & deal.II authors\r
+// Copyright (C) 2014 - 2015 by the Alexander Grayver & deal.II authors\r
 //\r
 // This file is part of the deal.II library.\r
 //\r
index bd0a4573281c546e54d176064a5e861aaa169e05..d782e38ea926a65726168cd8e385b3bff1c706de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 548578b7b8662b49ba395e8b4c5629cb982e0e81..1a25ecd1d65f9210005fd3b5774f1e7f5500a0d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c54799430ba00abec797c855efc25ac8ce9362af..01059f210660e1842ef9316134da8852ddc985a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa117e4be5ef30655907b00f8626246f47ebc9ab..23cc844f80f8703d9c7f79486d29796bfaef2092 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbe82c8152356874a00b49e5b57da367aa4526db..eb97aee60f0684ba06c6b1b16964af5530127a50 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0019fafd567e0a78b33f8c53d966c5a919885ea0..1f21c85b01a3862aef1264617344ab59a8938d03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 352c4398bc2ed72fe6884cd0d9665a950e6bcce3..e5c5da7773d76e1e06d568be16de5ce378a7e09f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43a89f13ad03eb45442bd611765c4cfb09577ad5..448ed202b5c911c5484e7fcaf9f755cf97d8f683 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 471688beab4de6f508e045f36d0f52bdf72a1a6e..864925b854b9ebc5e4bb7d47efb9aed2f87ebdda 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1084044adb6ba0545b5cefaefa871c6c17b4d993..a5da0a9b453ee83a77d6b1aa8398a77406e48a92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5de2332bfd27ec8e2ab8c4c35eb6ba28ba24e2c..10cb818399d5557bdb72e1d6d5e202faa31d1e81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80859f47312df02984c891c61fa073ffff636954..5e356c993cb83ef60c18db790ae2c34b6157132d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c1d673bed7a6f71968d4710b502caf7176052bb..2a0789c35aa134bf6fd1368375eea495d01cff5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38d41ef90b838c37c12bd2953c4757950fb0e4ba..3a724829a17458d1046bde1181f9a4de7867a846 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ac6f6f45e7a146282fbc11a6bcf9ccdba0c17ec..05a2c75c94906e742c85ad1438e6e9c7c15000dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78bf783e04238d52711ba04c7ac930a1b012abf3..e870d172e4c4074715c85fe639549f80876a869b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea179f3b51eb3affb72be1a88ba121ef41bd7daa..295054f8f88b62422b446400cdf97ca6a9039201 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0899b2f9a7d1cbb23edd75ca70552022538d6538..ef9757ed9886945af7d761417d94388c28284d75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5e1fa007bb0ef59badd04ed1ca3198358ddc814..39cb54a5a4cb2b467dd8f83567852c64b1a093c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f099801905d0ea8544676477da8e6ff5696c5ac2..8b4720796d799d413015af5fbd114140cd76c652 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3365e063f9011459339e8b19e141e90e64eacba4..edc8880fb37e259a89b2c567bf0ac95a659803a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa8dbcaab4ad5d4aa6b30913ae11ad113ec7886a..cfa3703ef1cfbc64adb833da4c705a0b256871c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d931d309d2e4e23106edbb70580f601e2c8b2fe6..f54d19bb98ccc148ef159fd8620d257dd9b7e431 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6aafb96a08a56280fe6c4d88227e1e1a9e4973d..aeeb11e64efc51e4831d3279f49e444a6d6fba12 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a9812ae6804666f87ddee0cbfd6742ea5a39c9c..253e7b01735b9d41c76e2fde75ce44f401722d4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1587ea10d5ff2d0906382387228451d50f5d6d1..bc552f0981d5802389a91d4afb88efa374df32a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fb70a4934164b8b52aeb37d4f4f48a950379f5f..fa549abe4a4646cb59e0a0a1df3aa5547e0d238a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8ab4358eb088d0b6158b82a4c278adceedf66d1..9c349c7ecc96d0d1f586f7acc12d41264a594cc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f797e4ca3ba3aa772eb49a338669506ef55e6c7..8bf18d504256be6e6befa13bd397664f6afb5149 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82f415beb879aaf363bac7ea643d91569f6fe85c..284a5cef055852c3434487cee9d9d0bd59f855fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 163e6d8f1e72feea6a41e4e95818fea36f15067c..b33f9a69adab34647da17d9ab229a0e1b537a0a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 187f90b5f95bcdab80f1227a930cf41d2a00b63b..f6aa4152e99ae90e598ea07a66ae751038000245 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c25fd2a8e89c2c5f54d033b32b7181e417e2a6b4..0bafa24e47e850206341279fbfc69b2af67ce27c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66d49bc464423a19f8807a2d390a93fceca3e075..8f4af570c2c869b9e0e86cc5603dbd74468d29d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab019803e64d21ec92f5377df331d1cef7d1b9df..4e8bb5a2a423824132b35b7958e10a44fcfa4cfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05feaf8d918eece791301c6335186342d139167c..a2fd613c2ff8a46fea0e5221fd55df236c33fb41 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1643b5122354aa9214db1d788b132c4f6c733b2b..84aa7e1e1f1ac00d738b96daa7c8e6911ec88f1c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84f9d1c18a79c7d671b00f7b9da2745ac9e20445..b86f3c7539c7dc61b0dc6862b196dadc0b26fe80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75b8e0c2c6ca24a711944542e2ea1d3b780ba666..e23ef73de7a665365486fd35756a82298d180686 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e226ff066bc3f81d139717310f7eacfa1946c47..d982e6f7c5fd58ac386fe7ed237f1968e8cbea0b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f84fd18ee30263ce242fc87c604e186ba481e5fe..fe4430d11a26cfca5ae99fdd78812ed11fc77ee2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7c6b64876650960541d9e799d4a9c2c5826487a..2cf26b8b66fd8480e62ce0f1775ff4e05209e9f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e67976394e9bb6b04060105b92724d24f2cb5533..ddad97156c81d323f78b2a30d1a427a0590be705 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eb7f429ff6012c82e1e80f04af49d50b9b48ae2..132618113f6717289faccfb1891c0055063117f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28a77b201a02e13de6cc46cab0c62b2b66ffbff8..1b6c9f203341b4fe2376aee35f63255f9f01adc8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc94cc8a9b34e6ef7973494482f675f9336ce0a3..d42fe9ace59a1fbd68913384fe172d6df80019be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 128265b7eb43c30bb9becf779596cdd1848814ec..4f03477c5b9f9fa72aa412606b35d563bb75aaa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c55661edd5550e01027fbd00bdf8245f1e9fdb5..6de936827c88ad800015ce3a629afddf72edc755 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3716b7df9106dac64a87545cb31d1cb5aea44346..5690477c2f0b6d1141b7950a9693656a3096cda3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cdc338c778bb97b9c1f858e836da9ede63fd209..760d270bd4be984330198ad8f64d6a9b1197b891 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc716415861d331170abc9a9a239bd155eb298f3..ee7f7954ac10ae97e9c6f41498b7659a84304007 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82f1596515370c630fb5d30b2be415efba475cb1..7ec9d070fa124451f85ef6f833f1edc8ada6244f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ece096cc022e5878eaf6f143075d47de3fd0d08..9f9645487ce3b3299d1e0fd281fb0a5a567ebd56 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a995bb0d71b8ffeed25f4d10a19fe9f848cc974..b9de7b731de7dd2d000ab360752ae08f28fe7bb3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e5b3482589d763e2337045e5bbc3ff76557b3bb..241c77d660e9ef438c81242ff5e526a11923ce2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8389ef69921a83816fb1cdf7d90a86e0b2562276..949b3387a7003e770c90fe2e3afed82660a0f1d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35d4efdc1d5e0ad6fc1b0054a5f504883459c559..23ae5b6a69e2aee6293ae5e51a9f3bcbf30bebad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0e307d51159137ba4a34a73f4b1a440f91805d8..a176fd70ac6e77c8a6968f5885e00188f6f117ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd379bb8532b77fd8cac06c983fe11a4ee75ae46..a0a77cb91370a4215e98849bbfe9635245667642 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8abc4f4be0669fed446359face119d4fc4200f9..f5467106e304030bffc60fdb013d3e1673d65ee3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97be0baa7d11100982d65f7f2d77bc20473189b7..7cf514045eafc424f0d1f50cd078e727ab0eadf1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a77d9128f7c364d7443c1919c59c4509201b08e..f4d971b837058f0aabca5daba4be6977fef8afff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b67ab90654a00b49d455f13d43b7e9331fd058e..74ef028d6fbeefa9bb0f056afff9b89af1a04b7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4d8f6bd29a45eb188dd599b03da5759354a6392..4cd4259521c5df35a535b604efbf6f725fac6a1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e08ce8017c83e5620b3ddb61229e4030e4b71385..79913e626dba6ad2786f73a7a57e70280b91b8b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c62f3a91d9ae7f4de1d0a52fdb9ba7cb8e5624d1..61470331a82be2ab5757e57ca9295a7be1d20e78 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------\r
  *\r
- * Copyright (C) 2013 - 2014 by the deal.II authors\r
+ * Copyright (C) 2013 - 2015 by the deal.II authors\r
  *\r
  * This file is part of the deal.II library.\r
  *\r
index 56b9a64af06d5766b05b4dcfcbcfe9f5d065c0c2..42f9d792430cc17c569b4e512aa0e4c407f02054 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------\r
  *\r
- * Copyright (C) 2013 - 2014 by the deal.II authors\r
+ * Copyright (C) 2013 - 2015 by the deal.II authors\r
  *\r
  * This file is part of the deal.II library.\r
  *\r
index 2875a4d96e4db9958f5e5cd5c03fe3273a62230b..b7e1c19c68e3d4edaed2f8c794dfa08f231ea7b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a9c886a4ec66e9a14b00e68e69c61834ffcba07..7eacc440a287376751c2fb8fab9071aefdf78c81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47166bab72ca90c3efa4625acc510d28fd6e8132..cbae4456337de813e8e692d10e74b81abff3f157 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39637078dc4232fd0910e349ccfebfe4e247d363..d3a6e70ea6842e468b640c25b2e53c7d875ee8f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9e27232ebc6093e73fd8d3dc2650128a5b6e499..8a2a5b38633683a20eb64b9a1110b74a71f41a23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d4c79b80c200364dc48d99fea67a2a21bbdcec1..59e7169680240626a845d814922eb5d688f32cea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 491ca7ce524e31eccee0093d19c3f69400db1e86..efce501979b388543170590c31dc2657847a67cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c04db3d7afd62c5a989a9bdbfe01353c666c82fe..6d00be3991a1dcf16630f21736527f1578d2ad9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e2797e13f5ca4e4b0e928db92edf24a30e4db24..d4541f29627c601bad778ffbdfe6f077eda347d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32a19980ba4cc414da710f37966e9f8b154b9cd9..4434b1e40905430ced80f61ade8ea2a27159fad0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a7ff6166d27acfe04758e1d293bd791d2ee2785..282bae6eb264a11053a18d9d2a7f8172df42013d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index effb64ca82bb7c7fd77727fd36280b3bdd78e810..a8e5b52a2bd34fb1ff22297a01ab3c1985dae13a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbb25b659cd161f0f0c2610267946c0bcc6934b7..5e3760d3f6fbd5e20e9928c0a8111c21dc83fa4a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b14df75d7efcd8dc3cef6518abe8b59b01a6e5d8..842e9e41d0de8138c1d32cefdaa61d3d377eef9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ec2852f5c79cd98038ee46bd695557e2dfc0cfa..b6d2e6c2db6e4b11a3e5a51e8064d0413db974d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75679ac313806bf51eb55107cac3dd6bf1872a62..237a9f2846e973a0174c8ba23538c2ed64848540 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfc9db38b6e88e888a6de15a9f4dbad730b81faa..4ce4e623703e7601484d1ff24c76ce55051bb59f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06c02d2657acfcded8b29b7a0797d01b525f369e..3ee562c52d0d5e3b76406d979eeccf4389b53031 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6273c88209d2ed58d66727cbf0066dbfc4241b0f..809c6d8e9e846ab48d92d4a956a5124d4623c710 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e21902f73baf1c389f9db558c80f3d08cc29342b..da97224b1c13e00662983a007c02e7b3e09ea1fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec6e982592157e8b38fc1948f7373a0f398d3414..65a23f474a44509eee784a1fa6b35c5d7623e021 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b5a5edd14e3759d37d0ec4a29b3c411633c0984..01f7ee2241d62ddd54f0229adc695ea958c16955 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d58ec1d5ae22d83dc2189c1af34e817b749baa4..517bd87a61bafe51ed261f3a977eb1b004ef2097 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 543d590200ecdd87a2aaceda85c33c48dab87300..de1d62b61f26707a04aae7346a96abd62a7c83a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 045951b6bb110a3ca0c9a9a4180824b1ac757617..81fe289bea97acf6360e8c8bdef3be548a9527f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e83bc07faa7168e4d396159398f7516d65dbadb..7d2bb2cbe5a7e1ce1caef66a6e21baf8eddfc554 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 864ac531cede9449ab65ef4c2c93cb8cd296421b..5c8aba07bc16f7f7610c9cae841d1a9002728aea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32afb34f7d76a784918549d313f92979ea23c745..40d58ca0b0693577ae4bb074c302b4421202b118 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08cd408eb4ed8102eeddfa051bcf297b5290b159..d641f36137313448cdfee5cb18684afb19b954e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81968d92c65a59ed4ce96b015b72d57597d0157d..c0d49953696c136a0cc6bd048de6952397a71952 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: dof_handler_number_cache.cc 31761 2013-11-22 14:42:37Z heister $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84c74d0230321905375f686310eaf290eb56b382..dd15f637058be12751709d0bb5a72fa2fdcd00a5 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: dof_handler_number_cache.cc 31761 2013-11-22 14:42:37Z heister $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14f74fd11670f07d041c8de48edfadbf17b43d96..09fb7105942db7428c9060bc19404e1f7d884fe1 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: dof_handler_number_cache.cc 31761 2013-11-22 14:42:37Z heister $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00ba70296e32337248d94bb65e8aa651a4c9f325..632cc25dbdd3749c7bb87302eebe5df5589604e2 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: dof_handler_number_cache.cc 31761 2013-11-22 14:42:37Z heister $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93d6f22130839ab27cc91d956c76616dff8b73fc..daf2e4fbca760c3787ec686dcf2cada227413f68 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: 3d_refinement_01.cc 31349 2013-10-20 19:07:06Z maier $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae8be13332c2bfbdd42ba0484ea5383405dca8ae..53b9a3c635f8c5ab9f219e897d2932506b3eec90 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id: 3d_refinement_01.cc 31349 2013-10-20 19:07:06Z maier $
 //
-// Copyright (C) 2008 - 2013, 2015 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5691f2a434207c0ddb4c9c62a79a20e95d4bb08f..4a8fe5e8a211226641510670c08b63265744a3a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93bcc4277afe8e51b305a9814e5027ef4b6fcd7d..f1da212bb3ee1a959ee7c60d6b46e3436822fb45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e22dcb382a12fce670de036f6596e509d95545f6..6fe702ba4350e80a136257a6dd7aa5718e951f67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2015 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29943e928dc59ca0418b1725de93fd164e3a013e..e8b52cfefa2886404b9c3c3dd98b941d88e89f97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8993156e925bfe264587a11ec13c4fe1e8025d0..95bdca3740993eff72221014b9bef572b91fe8bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6540bcf7b2844e990aa3a5ba8401ca31ad4c487..c021d413069d4366883737b195e9542c65521d67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af7895bccb71e2c302754a86cbcc4e4a30039d02..c88e5fa14fd157344c075f98f9c85f20aa550a35 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //

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.