From: bangerth Date: Sun, 19 Sep 2010 18:53:51 +0000 (+0000) Subject: In those directories in which now all .cc files correspond to tests, simplify the... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a99a1f26736218914e316aa483be55b05057a945;p=dealii-svn.git In those directories in which now all .cc files correspond to tests, simplify the Makefile. git-svn-id: https://svn.dealii.org/trunk@22075 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/a-framework/Makefile b/tests/a-framework/Makefile index e1317c8d3e..7de41a4da0 100644 --- a/tests/a-framework/Makefile +++ b/tests/a-framework/Makefile @@ -21,13 +21,8 @@ default: run-tests ############################################################ -tests_x = run miscompare compile link fail - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/aniso/Makefile b/tests/aniso/Makefile index cf05fb1cf9..e171efdc36 100644 --- a/tests/aniso/Makefile +++ b/tests/aniso/Makefile @@ -1,6 +1,6 @@ ############################################################ # $Id$ -# Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007 by the deal.II authors +# Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2010 by the deal.II authors ############################################################ ############################################################ @@ -21,19 +21,8 @@ default: run-tests ############################################################ -tests_x = refine_and_coarsen_anisotropic \ - fe_tools \ - solution_transfer \ - mesh_3d_21 \ - hp_constraints* \ - up_and_down - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) - +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/bits/Makefile b/tests/bits/Makefile index a4ef1f6a2d..7de41a4da0 100644 --- a/tests/bits/Makefile +++ b/tests/bits/Makefile @@ -21,103 +21,8 @@ default: run-tests ############################################################ -tests_x = grid_generator_?? \ - grid_in_* \ - point_inside_? \ - full_matrix_* \ - complex_real_full_matrix_* \ - complex_complex_full_matrix_* \ - block_matrix_array_* \ - data_out_0* \ - data_out_faces_0* \ - data_out_rotation_0* \ - data_out_stack_0* \ - data_out_curved_cells \ - dof_tools_[0-9]* \ - fe_tools_[0-9]* \ - fe_tools_cpfqpm* \ - fe_face_to_cell_index \ - fe_field_function \ - anna_? \ - gerold_? \ - roy_1 \ - denis_1 \ - unit_support_points \ - parameter_handler_* \ - multiple_parameter_loop_* \ - parsed_function \ - sparse_lu_decomposition_1 \ - block_sparse_matrix_* \ - block_vector_* \ - hyper_ball_3d \ - cylinder* \ - cone* \ - coarsening_3d \ - mesh_3d_* \ - normals_* \ - q_point_sum_* \ - volume_* \ - mapping_* \ - q_points \ - find_closest_vertex_* \ - find_cells_adjacent_to_vertex_* \ - find_cell_* \ - sparsity_pattern_* \ - sparse_matrix_* \ - chunk_sparse_matrix_* \ - full_matrix_vector_* \ - solver_* \ - deal_solver_* \ - vector_* \ - complex_vector_* \ - subdomain_ids_* \ - dof_constraints_* \ - apply_boundary_values_* \ - error_estimator_* \ - cylinder_shell_* \ - compressed_sparsity_pattern_* \ - compressed_set_sparsity_pattern_* \ - point_difference_* \ - point_value_* \ - fe_q_3d* \ - rt_* \ - nedelec_* \ - get_fe_from_name \ - christian_* \ - oliver_* \ - accessor_equality* \ - get_dof_indices_* \ - n_dofs_per_object \ - step-* \ - hp_constraints* \ - face_interpolation \ - subface_interpolation \ - face_orientation_crash \ - refine_and_coarsen_* \ - tria_crash_* \ - face_orientation_* \ - max_n_cells_* \ - joa_* \ - neighboring_cells_at_two_faces \ - solution_transfer \ - make_boundary_constraints_* \ - count_dofs_per_block* \ - distorted_cells_* - -ifeq ($(USE_CONTRIB_METIS),yes) - tests_x += metis_* -endif - -ifeq ($(USE_CONTRIB_HSL),yes) - tests_x += hsl_* -endif - - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/codim_one/Makefile b/tests/codim_one/Makefile index 23166cbb71..27ec68f227 100644 --- a/tests/codim_one/Makefile +++ b/tests/codim_one/Makefile @@ -21,25 +21,8 @@ default: run-tests ############################################################ -tests_x = grid* \ - mapping* \ - interpolation* \ - surface* \ - data_out* \ - projection*\ - integrate*\ - gradients*\ - tensor_matrix_conversion*\ - bem* - - - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) - +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/deal.II/Makefile b/tests/deal.II/Makefile index 5a323d5e13..6c169ddcb3 100644 --- a/tests/deal.II/Makefile +++ b/tests/deal.II/Makefile @@ -21,80 +21,8 @@ default: run-tests ############################################################ -tests_x = block_info block_matrices \ - user_data_* \ - constraint* \ - inhomogeneous_constraints \ - inhomogeneous_constraints_nonsymmetric \ - inhomogeneous_constraints_block \ - inhomogeneous_constraints_vector \ - data_out \ - derivative_* \ - derivatives \ - dof_test \ - dof_renumbering \ - dof_renumbering_* \ - error_estimator \ - grid_invert \ - grid_generator* \ - grid_out \ - grid_out_* \ - grid_output_input \ - grid_test \ - grid_transform \ - grid_transform_3d \ - grid_hyper_* \ - measure_et_al \ - extent_in_direction \ - normals_at_vertices \ - intergrid_constraints \ - intergrid_map \ - matrices \ - vectors_* \ - support_point_map \ - filtered_matrix \ - boundaries \ - sparsity_pattern* \ - grid_tools \ - subdomain_* \ - filtered_iterator* \ - grid_in* \ - grid_in_3d \ - face_orientations_3d \ - mg_dof_handler \ - subcelldata \ - interpolate_* \ - have_same_coarse_mesh_* \ - get_finest_common_cells_* \ - project_*[0-9] \ - project_boundary_* \ - project_to_surface_* \ - minimal_cell_diameter \ - maximal_cell_diameter \ - union_triangulation \ - iterators* \ - mesh_smoothing_* \ - create_* \ - mesh_worker_* \ - line_coarsening_3d \ - no_flux_* \ - fe_values_view_* \ - fe_values_extractor_* \ - rt_hessian \ - rt_covariant \ - coarsening_* \ - number_cache_* \ - kelly_crash_* \ - recursively_set_material_id \ - point_value_history_* \ - newton_* - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) - +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/fail/Makefile b/tests/fail/Makefile index 753a1722a3..beb9a6d6e4 100644 --- a/tests/fail/Makefile +++ b/tests/fail/Makefile @@ -1,6 +1,6 @@ ############################################################ # Makefile,v 1.15 2002/06/13 12:51:13 hartmann Exp -# Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors +# Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2010 by the deal.II authors ############################################################ ############################################################ @@ -21,8 +21,7 @@ default: run-tests ############################################################ -# all .cc-files are tests by default. - +# all .cc-files are tests: tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/fe/Makefile b/tests/fe/Makefile index d823b744b1..0c8b3866bd 100644 --- a/tests/fe/Makefile +++ b/tests/fe/Makefile @@ -1,6 +1,6 @@ ############################################################ # Makefile,v 1.15 2002/06/13 12:51:13 hartmann Exp -# Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors +# Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors ############################################################ ############################################################ diff --git a/tests/hp/Makefile b/tests/hp/Makefile index cbc3d28b5f..6c169ddcb3 100644 --- a/tests/hp/Makefile +++ b/tests/hp/Makefile @@ -21,35 +21,8 @@ default: run-tests ############################################################ -tests_x = hp_dof_handler \ - crash_* \ - q_collection_* \ - mapping_collection_* \ - fe_collection_* \ - fe_nothing_* \ - continuous_* \ - n_dofs \ - random \ - step-* \ - n_active_fe_indices \ - integrate_difference \ - hp_*_dof_identities_* \ - hp_hanging_nodes_* \ - interpolate_* \ - hp_constraints_* \ - matrices* \ - vectors* \ - get_active_fe_indices \ - create_* \ - renumber_* \ - dof_renumbering_* \ - compare* - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################ diff --git a/tests/lac/Makefile b/tests/lac/Makefile index c4db3fd013..57cfc6c057 100644 --- a/tests/lac/Makefile +++ b/tests/lac/Makefile @@ -20,52 +20,8 @@ default: run-tests ############################################################ -tests_x = vector-vector vector_memory \ - full_matrix* \ - householder \ - tridiagonal_matrix \ - tridiagonal_matrix_sym \ - sparsity_tools_* \ - sparsity_pattern \ - sparsity_pattern_* \ - chunk_sparsity_pattern_* \ - compressed_sparsity_pattern_* \ - compressed_simple_sparsity_pattern_* \ - compressed_set_sparsity_pattern_* \ - constraints_zero* \ - constraints_inhomogeneous \ - constraint_graph_zero \ - sparse_matrices matrices \ - block_sparsity_pattern_* \ - block_indices \ - block_vector \ - block_vector_* \ - block_matrices \ - is_block_matrix \ - is_block_vector \ - matrix_lib \ - matrix_out \ - pointer_matrix \ - pointer_matrix_vector \ - solver solver_selector_* solver_relaxation_* \ - eigen \ - filtered_matrix \ - sparse_ilu* \ - lapack_fill \ - block_minres \ - identity_matrix* \ - trace \ - print_formatted_* \ - bicgstab_early \ - complex* \ - vector_view* - - -# from above list of regular expressions, generate the real set of -# tests -expand = $(shell echo $(addsuffix .cc,$(1)) \ - | $(PERL) -pi -e 's/\.cc//g;') -tests = $(call expand,$(tests_x)) +# all .cc-files are tests: +tests = $(basename $(wildcard *.cc)) ############################################################