LINK_FLAGS "${DEAL_II_SHARED_LINKER_FLAGS_${_build}}"
COMPILE_DEFINITIONS "${DEAL_II_DEFINITIONS};${DEAL_II_DEFINITIONS_${_build}}"
COMPILE_FLAGS "${DEAL_II_CXX_FLAGS_${_build}}"
+ LINKER_LANGUAGE "CXX"
)
FILE(APPEND
ADD_SUBDIRECTORY(multigrid)
ADD_SUBDIRECTORY(distributed)
+ADD_SUBDIRECTORY(algorithms)
+
FOREACH(build ${DEAL_II_BUILD_TYPES})
STRING(TOLOWER ${build} build_lowercase)
--- /dev/null
+#####
+##
+## Copyright (C) 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## <TODO: Full License information>
+## This file is dual licensed under QPL 1.0 and LGPL 2.1 or any later
+## version of the LGPL license.
+##
+## Author: Matthias Maier <matthias.maier@iwr.uni-heidelberg.de>
+##
+#####
+
+INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
+
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/algorithms/*.h
+ )
+
+SET(_src
+ )
+
+DEAL_II_ADD_LIBRARY(obj_algorithms OBJECT ${_src} ${_header})
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src_base
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/base/*.h
+ )
+
+SET(_src
auto_derivative_function.cc
conditional_ostream.cc
config.cc
utilities.cc
)
-DEAL_II_ADD_LIBRARY(obj_base OBJECT ${src_base})
+DEAL_II_ADD_LIBRARY(obj_base OBJECT ${_src} ${_header}
+ ${CMAKE_BINARY_DIR}/include/deal.II/base/config.h
+ )
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/distributed/*.h
+ )
+
+SET(_src
grid_refinement.cc
solution_transfer.cc
tria.cc
)
-SET(inst_in_files
+SET(_inst
grid_refinement.inst.in
solution_transfer.inst.in
tria.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_distributed OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_distributed "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_distributed OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_distributed "${_inst}")
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/dofs/*.h
+ )
+
+SET(_src
block_info.cc
dof_accessor.cc
dof_faces.cc
number_cache.cc
)
-SET(inst_in_files
+SET(_inst
block_info.inst.in
dof_accessor.inst.in
dof_handler.inst.in
dof_tools.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_dofs OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_dofs "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_dofs OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_dofs "${_inst}")
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/fe/*.h
+ )
+
+SET(_src
block_mask.cc
component_mask.cc
fe_abf.cc
mapping_q_eulerian.cc
)
-SET(inst_in_files
+SET(_inst
fe_abf.inst.in
fe_bdm.inst.in
fe_dgp.inst.in
mapping_q.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_fe OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_fe "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_fe OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_fe "${_inst}")
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/grid/*.h
+ )
+
+SET(_src
grid_generator.cc
grid_in.cc
grid_out.cc
tria_objects.cc
)
-SET(inst_in_files
+SET(_inst
grid_generator.inst.in
grid_in.inst.in
grid_out.inst.in
tria_objects.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_grid OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_grid "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_grid OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_grid "${_inst}")
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/hp/*.h
+ )
+
+SET(_src
dof_faces.cc
dof_handler.cc
dof_levels.cc
mapping_collection.cc
)
-SET(inst_in_files
+SET(_inst
dof_handler.inst.in
fe_collection.inst.in
fe_values.inst.in
mapping_collection.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_hp OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_hp "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_hp OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_hp "${_inst}")
--- /dev/null
+#####
+##
+## Copyright (C) 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## <TODO: Full License information>
+## This file is dual licensed under QPL 1.0 and LGPL 2.1 or any later
+## version of the LGPL license.
+##
+## Author: Matthias Maier <matthias.maier@iwr.uni-heidelberg.de>
+##
+#####
+
+INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
+
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/integrators/*.h
+ )
+
+SET(_src
+ )
+
+DEAL_II_ADD_LIBRARY(obj_integrators OBJECT ${_src} ${_header})
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/lac/*.h
+ )
+
+SET(_src
block_matrix_array.cc
block_sparse_matrix.cc
block_sparse_matrix_ez.cc
vector_view.cc
)
-SET(inst_in_files
+SET(_inst
block_sparse_matrix.inst.in
block_vector.inst.in
chunk_sparse_matrix.inst.in
vector_view.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_lac OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_lac "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_lac OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_lac "${_inst}")
--- /dev/null
+#####
+##
+## Copyright (C) 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## <TODO: Full License information>
+## This file is dual licensed under QPL 1.0 and LGPL 2.1 or any later
+## version of the LGPL license.
+##
+## Author: Matthias Maier <matthias.maier@iwr.uni-heidelberg.de>
+##
+#####
+
+INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
+
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/matrix_free/*.h
+ )
+
+SET(_src
+ )
+
+DEAL_II_ADD_LIBRARY(obj_matrix_free OBJECT ${_src} ${_header})
--- /dev/null
+#####
+##
+## Copyright (C) 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## <TODO: Full License information>
+## This file is dual licensed under QPL 1.0 and LGPL 2.1 or any later
+## version of the LGPL license.
+##
+## Author: Matthias Maier <matthias.maier@iwr.uni-heidelberg.de>
+##
+#####
+
+INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
+
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/mesh_worker/*.h
+ )
+
+SET(_src
+ )
+
+DEAL_II_ADD_LIBRARY(obj_mesh_worker OBJECT ${_src} ${_header})
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/multigrid/*.h
+ )
+
+SET(_src
mg_base.cc
mg_dof_handler.cc
mg_tools.cc
multigrid.cc
)
-SET(inst_in_files
+SET(_inst
mg_base.inst.in
mg_dof_handler.inst.in
mg_tools.inst.in
multigrid.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_multigrid OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_multigrid "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_multigrid OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_multigrid "${_inst}")
INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR})
-SET(src
+FILE(GLOB _header
+ ${CMAKE_SOURCE_DIR}/include/deal.II/numerics/*.h
+ )
+
+SET(_src
data_out.cc
data_out_faces.cc
data_out_rotation.cc
vector_tools.cc
)
-SET(inst_in_files
+SET(_inst
data_out_faces.inst.in
data_out.inst.in
data_out_rotation.inst.in
vector_tools.inst.in
)
-DEAL_II_ADD_LIBRARY(obj_numerics OBJECT ${src})
-EXPAND_INSTANTIATIONS(obj_numerics "${inst_in_files}")
+DEAL_II_ADD_LIBRARY(obj_numerics OBJECT ${_src} ${_header} ${_inst})
+EXPAND_INSTANTIATIONS(obj_numerics "${_inst}")