+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef AUXILIARY_FUNCTIONS
#define AUXILIARY_FUNCTIONS
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef INTEGRATE_SYSTEM
#define INTEGRATE_SYSTEM
}
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "LimitSolution.h"
namespace TravelingWave
}
}
-} // namespace TravelingWave
\ No newline at end of file
+} // namespace TravelingWave
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef LIMIT_SOLUTION
#define LIMIT_SOLUTION
} // namespace TravelingWave
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef LINEAR_INTERPOLATOR
#define LINEAR_INTERPOLATOR
return res;
}
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "Parameters.h"
namespace TravelingWave
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef PARAMETERS
#define PARAMETERS
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "Solution.h"
namespace TravelingWave
template class SolutionVectorFunction<Interpolant>;
-} // namespace TravelingWave
\ No newline at end of file
+} // namespace TravelingWave
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef SOLUTION
#define SOLUTION
} // namespace TravelingWave
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "TravelingWaveSolver.h"
namespace TravelingWave
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef TRAVELING_WAVE_SOLVER
#define TRAVELING_WAVE_SOLVER
} // namespace TravelingWave
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "TravelingWaveSolver.h"
#include "calculate_profile.h"
}
-} // namespace TravelingWave
\ No newline at end of file
+} // namespace TravelingWave
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#ifndef CALCULATE_PROFILE
#define CALCULATE_PROFILE
} // namespace TravelingWave
-#endif
\ No newline at end of file
+#endif
+/* -----------------------------------------------------------------------------
+ *
+ * SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+ * Copyright (C) 2024 by Shamil Magomedov
+ *
+ * This file is part of the deal.II code gallery.
+ *
+ * -----------------------------------------------------------------------------
+ */
+
#include "calculate_profile.h"
int main(int argc, char *argv[])
+## -----------------------------------------------------------------------------
+##
+## SPDX-License-Identifier: Apache-2.0 WITH LLVM-exception OR LGPL-2.1-or-later
+## Copyright (C) 2024 by Shamil Magomedov
+##
+## This file is part of the deal.II code gallery.
+##
+## -----------------------------------------------------------------------------
+##
+
import numpy as np
import matplotlib.pyplot as plt
import os