Skip to content

Commit

Permalink
Quinoa v0.3, 2020 summer
Browse files Browse the repository at this point in the history
Quinoa is a set of computational tools that enables research and
numerical analysis in fluid dynamics. Using the Charm++ runtime system,
we employ asynchronous (or non-blocking) parallel programming and
decompose computational problems into a large number of work units (that
may be more than the available number of processors) enabling arbitrary
overlap of parallel computation, communication, input, and output. Then
the runtime system dynamically and automatically homogenizes
computational load across the simulation distributed across many
computers.

Quinoa consists of the following tools:

(1) Walker, a mathematical tool to analyze and design the behavior of
stochastic differential equations.  Solving a multivariate Fokker-Planck
equation, it allows the estimation of arbitrary coupled statistics and
probability distributions as they evolve in time and is used for the
design of statistical moment approximations for turbulent flows in
engineering.

(2) Inciter, is a distributed-memory-parallel fluid solver for complex
3D engineering geometries. Inciter can solve the Euler equations,
modeling ideal single-material compressible flow, using continuous and
discontinuous Galerkin finite element methods, with solution-adaptive
mesh-, and polynomial-degree refinement, enabling dynamically
concentrating compute resources to regions with interesting physics.
Compared to the previous release (LA-CC-17-087) current development
continues in the following directions: (A) a new solver for
multi-material flows (single velocity, multiple densities, multiple mass
fractions, and multiple internal energies) solving the Euler equations
for simple ideal gases, (B) polynomial adaptation for both single-, and
multi-material flows, (C) productize the solvers (i.e., increase
robustness, user-friendliness, and add practicality features), and (D)
prototype implementation of 3D parallel mesh-to-mesh solution transfer
to enable fluid-structure interaction problems, coupling compressible
flow with the kinematics of rigid body motion of objects embedded in a
fluid flow, allowing the computation of body motion in response to
aerodynamic forces.

(3) RNGTest, a test harness to subject random number generators to
stringent statistical tests enabling quantitative ranking with respect
to their quality and computational cost.

(4) UnitTest, a unit test harness, running hundreds of tests per second,
capable of testing serial, synchronous, and asynchronous functions.

(5) MeshConv, a mesh file converter that can be used to convert 3D
tetrahedron meshes to and from the following formats:

* Gmsh, http://www.geuz.org/gmsh,
* Netgen, http://sourceforge.net/apps/mediawiki/netgen-mesher,
* ExodusII/SEACAS, https://github.com/gsjaardema/seacas,
* HyperMesh, https://www.altair.com/hypermesh,
* ASC, https://www.researchgate.net/scientific-contributions/2014382994_Jacob_Waltz,
* Omega_h, https://github.com/SNLComputation/omega_h,
* UGRID, http://www.simcenter.msstate.edu/software/downloads/doc/ug_io,
* RDGFLO, https://www.mae.ncsu.edu/people/hluo2.
  • Loading branch information
jbakosi committed Sep 12, 2020
2 parents 8102401 + 7b864d7 commit 2dd7ead
Show file tree
Hide file tree
Showing 1,585 changed files with 158,369 additions and 8,965 deletions.
2 changes: 1 addition & 1 deletion LICENSE
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
Copyright (c) 2012-2015, J. Bakosi
Copyright (c) 2016-2018, Los Alamos National Security, LLC
Copyright (c) 2019, Triad National Security, LLC
Copyright (c) 2019-2020, Triad National Security, LLC
All rights reserved.

This program was produced under U.S. Government contract 89233218CNA000001 for
Expand Down
4 changes: 3 additions & 1 deletion README.md
Original file line number Diff line number Diff line change
Expand Up @@ -18,6 +18,8 @@ problems with a production-quality code that is extensible and maintainable,
using hardware resources efficiently, even for problems with _a priori_
unknown, heterogeneous, and dynamic load distribution.

This software has been acknowledged by the U.S. Department of Energy / National
Nuclear Security Administration for open source release, C20072.

For more details on philosophy, documentation, software design, journal papers,
license, and contributing see the [documentation](https://quinoacomputing.org).

2 changes: 1 addition & 1 deletion cmake/BuildShared.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file BuildShared.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Set default value for building shared libs if none was specified
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/BuildType.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file BuildType.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Set a default build type if none was specified
#
Expand Down
4 changes: 2 additions & 2 deletions cmake/CodeCoverage.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file CodeCoverage.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Setup target for code coverage analysis
#
Expand Down Expand Up @@ -169,7 +169,7 @@ FUNCTION(SETUP_TARGET_FOR_ALL_COVERAGE suite path targetname unittestrunner
COMMAND ${FASTCOV} --zerocounters
# Run all test suites
COMMAND ${unittestrunner} ${unittestrunner_ncpus_arg} ${PROCESSOR_COUNT} Main/${UNITTEST_EXECUTABLE} -v
COMMAND ${CMAKE_CTEST_COMMAND} -j${PROCESSOR_COUNT} -LE insane
COMMAND ${CMAKE_CTEST_COMMAND} -j${PROCESSOR_COUNT} #-LE insane
# Process gcov output for genhtml
COMMAND ${FASTCOV} --branch-coverage --exceptional-branch-coverage --lcov -o ${OUTPUT}.info --exclude tests/ c++/ include/ boost/ charm/ decl.h def.h openmpi pstreams Random123 pegtl tut/ highwayhash/ moduleinit
# Copy over report customization files for genhtml
Expand Down
2 changes: 1 addition & 1 deletion cmake/ConfigExecutable.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file ConfigExecutable.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Configure Charm++ executable targets
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/ConfigureDataLayout.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file ConfigureDataLayout.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Configure data layouts
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/CppCheck.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file CppCheck.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Setup target for code coverage analysis
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/DetectCodeCoverage.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file DetectCodeCoverage.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Detect prerequesites for code coverage analysis
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/DetectCompilerVersion.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file DetectCompilerVersion.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Detect C, C++, Fortran compiler major, minor, and patch version
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/DetectOS.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file DetectOS.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Detect operating system
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/DisallowInSourceBuilds.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file DisallowInSourceBuilds.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Cmake code to disallow in-source builds
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindAEC.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindAEC.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Adaptive Entropy Coding library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindBackwardCpp.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindBackwardCpp.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Backward-cpp header-only library
# \note BackwardCPP requires other libraries, and for a static build,
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindBrigand.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindBrigand.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Brigand template metaprogramming library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindCharm.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindCharm.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find Charm++
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindExodiff.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindExodiff.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find Exodiff
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindGmsh.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindGmsh.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find Gmsh
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindH5Part.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindH5Part.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the H5Part library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindHighwayHash.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindHighwayHash.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find HighwayHash
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindHypre.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindHypre.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Hypre library from LLNL
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindLAPACKE.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindLAPACKE.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the C-interface to LAPACK as well as LAPACK/BLAS
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindLibCXX.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindLibCXX.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find libc++
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindMCSS.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindMCSS.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find m.css
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindMKL.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindLMKL.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Math Kernel Library from Intel
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindNetCDF.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file cmake/FindLNetCDF.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find NetCDF
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindNumDiff.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindNumDiff.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find NumDiff
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindOmega_h.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindOmega_h.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Omega_h library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindPEGTL.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindPEGTL.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find PEGTL
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindPStreams.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindLPstreams.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Pstreams library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindPugixml.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file cmake/FindPugixml.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the pugixml library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindRNGSSE2.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindRNGSSE2.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the RNGSSE2 library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindRandom123.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindRandom123.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find Random123
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindRoot.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindRoot.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Root library from CERN
#
Expand Down
47 changes: 47 additions & 0 deletions cmake/FindSol2.cmake
Original file line number Diff line number Diff line change
@@ -0,0 +1,47 @@
################################################################################
#
# \file FindSol2.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Sol2 Lua C++ binding library
#
################################################################################

# Sol2: https://github.com/ThePhD/sol2
#
# SOL2_FOUND - System has Sol2
# SOL2_INCLUDE_DIRS - The Sol2 include directory
#
# Set the SOL2_ROOT cmake variable or shell environment variable before
# calling find_package to a path to add an additional search path, e.g.,
#
# Usage:
#
# set(SOL2_ROOT "/path/to/custom/brigand") # prefer over system
# find_package(Sol2)
# include_directories(${SOL2_INCLUDE_DIRS})

# If already in cache, be silent
if(SOL2_INCLUDE_DIRS)
set (SOL2_FIND_QUIETLY TRUE)
endif()

find_path(SOL2_INCLUDE_DIR NAMES sol.hpp
HINTS ${SOL2_ROOT}
$ENV{SOL2_ROOT}
PATH_SUFFIXES sol include)

# Remove last 'sol' from path found, otherwise some compilers will not find
# sol.hpp.
get_filename_component(SOL2_INCLUDE_DIR ${SOL2_INCLUDE_DIR} DIRECTORY)

set(SOL2_INCLUDE_DIRS ${SOL2_INCLUDE_DIR})

# Handle the QUIETLY and REQUIRED arguments and set SOL2_FOUND to TRUE if
# all listed variables are TRUE.
INCLUDE(FindPackageHandleStandardArgs)
FIND_PACKAGE_HANDLE_STANDARD_ARGS(Sol2 REQUIRED_VARS SOL2_INCLUDE_DIRS)

MARK_AS_ADVANCED(SOL2_INCLUDE_DIRS)
2 changes: 1 addition & 1 deletion cmake/FindTUT.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindTUT.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the Template Unit Test library headers
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/FindTestU01.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file FindTestU01.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the TestU01 library
#
Expand Down
2 changes: 1 addition & 1 deletion cmake/LICENSE
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
Copyright (c) 2012-2015, J. Bakosi
Copyright (c) 2016-2018, Los Alamos National Security, LLC
Copyright (c) 2019, Triad National Security, LLC
Copyright (c) 2019-2020, Triad National Security, LLC
All rights reserved.

This program was produced under U.S. Government contract 89233218CNA000001 for
Expand Down
2 changes: 1 addition & 1 deletion cmake/MPICompilers.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
# \file MPICompilers.cmake
# \copyright 2012-2015 J. Bakosi,
# 2016-2018 Los Alamos National Security, LLC.,
# 2019 Triad National Security, LLC.
# 2019-2020 Triad National Security, LLC.
# All rights reserved. See the LICENSE file for details.
# \brief Find the MPI wrappers
#
Expand Down
Loading

0 comments on commit 2dd7ead

Please sign in to comment.