]> https://gitweb.dealii.org/ - code-gallery.git/commitdiff
Another round of typo fixing: changed 'stap' to 'step' in builds on, added the approp... 146/head
authorUbuntu <uneake0h51@gmail.com>
Thu, 25 May 2023 20:09:35 +0000 (20:09 +0000)
committerUbuntu <uneake0h51@gmail.com>
Thu, 25 May 2023 20:09:35 +0000 (20:09 +0000)
Swift-Hohenberg-Solver/Generalized-Swift-Hohenberg-Solver.cc
Swift-Hohenberg-Solver/README.md
Swift-Hohenberg-Solver/doc/builds-on

index 5c57544c9df0a3b68451648833d42cabff584250..d88478bf21a6fdae5f1ffdac74d0f5329084e770 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2013 - 2023 by the deal.II authors
+ * Copyright (C) 2023 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -142,7 +142,6 @@ namespace SwiftHohenbergSolver
     SHEquation(const unsigned int degree
                 , double time_step_denominator
                 , unsigned int ref_num
-                /* , unsigned int iteration_number */
                 , double r_constant = 0.5
                 , double g1_constant = 0.5
                 , std::string output_file_name = "solution-"
index 147efa72a46e2033a1659143ef05c60942d0a589..a7e0925e6231ae8afc12628af1906dc49ae6838b 100755 (executable)
@@ -31,10 +31,10 @@ $$\begin{aligned}
 \end{aligned}$$\r
 \r
 We can solve these two equations simultaneously by treating our\r
-finite elements as vector valued, and interpretting our system of\r
+finite elements as vector valued, and interpreting our system of\r
 equations as a single vector-valued PDE. We can handle the nonlinear\r
 terms by treating them fully explicitly. If we discretize in time and\r
-Backrange terms, our system of equations becomes \r
+rearrange terms, our system of equations becomes \r
 \r
 $$\begin{aligned}\r
         (1 - kr)U_n + k(1 + \Delta)V_n &= U_{n-1} + kg_1U_{n-1}^2 - kU_{n-1}^3\\\r
@@ -69,10 +69,10 @@ $$\overrightarrow\varphi_i = \begin{pmatrix}
     \psi_i\r
 \end{pmatrix}$$\r
 \r
-to get the equation\r
+and then integrate over the domain $\Omega$ to get the equation\r
 \r
 $$\begin{aligned}\r
-    \begin{pmatrix}\r
+    \int_\Omega \begin{pmatrix}\r
             \phi_i\\ \r
                 \psi_i\r
         \end{pmatrix}\cdot\begin{pmatrix}\r
@@ -82,7 +82,7 @@ $$\begin{aligned}
         \begin{pmatrix}\r
             U_n\\\r
             V_n\r
-        \end{pmatrix} &= \begin{pmatrix}\r
+        \end{pmatrix} &= \int_\Omega \begin{pmatrix}\r
             \phi_i\\\r
                \psi_i\r
         \end{pmatrix}\cdot\begin{pmatrix}\r
@@ -91,10 +91,10 @@ $$\begin{aligned}
         \end{pmatrix}\\\r
 \end{aligned}$$\r
 \r
-and then expand our solution vector in this basis\r
+We can expand our solution vector in this basis\r
 \r
 $$\begin{aligned}\r
-    \sum_j u_j\begin{pmatrix}\r
+    \int_\Omega \sum_j u_j\begin{pmatrix}\r
             \phi_i\\\r
                    \psi_i\r
         \end{pmatrix}\cdot\begin{pmatrix}\r
@@ -104,7 +104,7 @@ $$\begin{aligned}
         \begin{pmatrix}\r
             \phi_j\\\r
             \psi_j\r
-        \end{pmatrix} &= \begin{pmatrix}\r
+        \end{pmatrix} &= \int_\Omega\begin{pmatrix}\r
             \phi_i\\\r
                    \psi_i\r
         \end{pmatrix}\cdot\begin{pmatrix}\r
@@ -113,12 +113,12 @@ $$\begin{aligned}
         \end{pmatrix}\r
 \end{aligned}$$\r
 \r
-The last step is to expand out the matrix multiplication\r
-and dot products, integrate, and apply the divergence theorem to obtain\r
+and finally expand out the matrix multiplication\r
+and dot products, then apply the divergence theorem to obtain\r
 a single equation:\r
 \r
 $$\begin{aligned}\r
-    \sum_j u_j [(1 - kr)\phi_i\phi_j + k\phi_i\psi_j - k\nabla\phi_i\nabla\psi_j + \psi_i\phi_j - \nabla\psi_i\nabla\psi_j - \psi_i\psi_j] &= \phi_i(U_{n-1} + kg_1U_{n-1}^2 - kU_{n-1}^3)\r
+    \sum_j u_j \int_\Omega[(1 - kr)\phi_i\phi_j + k\phi_i\psi_j - k\nabla\phi_i\nabla\psi_j + \psi_i\phi_j - \nabla\psi_i\nabla\psi_j - \psi_i\psi_j] &= \int_\Omega\phi_i(U_{n-1} + kg_1U_{n-1}^2 - kU_{n-1}^3)\r
 \end{aligned}$$\r
 \r
 This last equation represents matrix multiplication of the\r
@@ -129,7 +129,7 @@ compute the $(i, j)^{th}$ entry of the system matrix.
 # Boundary Conditions and Choosing a Suitable Domain\r
 \r
 This code implements both zero Dirichlet and zero Neumann boundary\r
-conditions. Both these conditions affect the patterns that form. To\r
+conditions. Both of these conditions affect the patterns that form. To\r
 minimize this effect, we use Neumann boundary conditions and we choose\r
 the boundary to be some multiple of the wave number. For example, this\r
 code chooses the square mesh to have a side length of $6\cdot 2\pi$.\r
@@ -153,7 +153,7 @@ parameters in the SH equation.
 \r
 The hot spot initial condition is useful for the opposite reason: it is\r
 very simple, but it lets us see what happens to a single pattern\r
-\"wavelength\" as it propagates along our surface. This is particularly\r
+\"wave\" as it propagates along our surface. This is particularly\r
 useful in distinguishing the effect of curvature and geometry on pattern\r
 propagation.\r
 \r
@@ -211,7 +211,7 @@ pieces as $g_1$ is increased. In the matrix below, $g_1$ is
 increased by 0.2 starting from 0 to a maximum value of 1.4. Note that\r
 each final solution is at 100 time units:\r
 \r
-![image](doc/images/Sphere_Hotspot_Table.png)\r
+![image](doc/images/Square_Hotspot_Table.png)\r
 \r
 On the cylinder, the front looks similar to the square, but the back has\r
 an overlapping wave pattern:\r
index 69d4abb25fc7da78b6ef927630aaf16807c2b78b..b3ca2636c2cdc187478f09ccee8c614a71243ce8 100755 (executable)
@@ -1 +1 @@
-stap-26
\ No newline at end of file
+step-26
\ No newline at end of file

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.