Branch data Line data Source code
1 : : // *****************************************************************************
2 : : /*!
3 : : \file src/Inciter/DG.cpp
4 : : \copyright 2012-2015 J. Bakosi,
5 : : 2016-2018 Los Alamos National Security, LLC.,
6 : : 2019-2021 Triad National Security, LLC.
7 : : All rights reserved. See the LICENSE file for details.
8 : : \brief DG advances a system of PDEs with the discontinuous Galerkin scheme
9 : : \details DG advances a system of partial differential equations (PDEs) using
10 : : discontinuous Galerkin (DG) finite element (FE) spatial discretization (on
11 : : tetrahedron elements) combined with Runge-Kutta (RK) time stepping.
12 : : \see The documentation in DG.h.
13 : : */
14 : : // *****************************************************************************
15 : :
16 : : #include <algorithm>
17 : : #include <numeric>
18 : : #include <sstream>
19 : :
20 : : #include "DG.hpp"
21 : : #include "Discretization.hpp"
22 : : #include "DGPDE.hpp"
23 : : #include "DiagReducer.hpp"
24 : : #include "DerivedData.hpp"
25 : : #include "ElemDiagnostics.hpp"
26 : : #include "Inciter/InputDeck/InputDeck.hpp"
27 : : #include "Refiner.hpp"
28 : : #include "Limiter.hpp"
29 : : #include "Reorder.hpp"
30 : : #include "Vector.hpp"
31 : : #include "Around.hpp"
32 : : #include "Integrate/Basis.hpp"
33 : : #include "FieldOutput.hpp"
34 : : #include "ChareStateCollector.hpp"
35 : : #include "PDE/MultiMat/MultiMatIndexing.hpp"
36 : :
37 : : namespace inciter {
38 : :
39 : : extern ctr::InputDeck g_inputdeck;
40 : : extern std::vector< DGPDE > g_dgpde;
41 : :
42 : : //! Runge-Kutta coefficients
43 : : static const std::array< std::array< tk::real, 3 >, 2 >
44 : : rkcoef{{ {{ 0.0, 3.0/4.0, 1.0/3.0 }}, {{ 1.0, 1.0/4.0, 2.0/3.0 }} }};
45 : :
46 : : //! Implicit-Explicit Runge-Kutta Coefficients
47 : : static const tk::real rk_gamma = (2.0-std::sqrt(2.0))/2.0;
48 : : static const tk::real rk_delta = -2.0*std::sqrt(2.0)/3.0;
49 : : static const tk::real c2 =
50 : : (27.0 + std::pow(2187.0-1458.0*std::sqrt(2.0),1.0/3.0)
51 : : + 9.0*std::pow(3.0+2.0*std::sqrt(2.0),1.0/3.0))/54.0;
52 : : static const tk::real c3 = c2/(6.0*std::pow(c2,2.0)-3.0*c2+1.0);
53 : : static const tk::real b2 = (3.0*c2-1.0)/(6.0*std::pow(c2,2.0));
54 : : static const tk::real b3 =
55 : : (6.0*std::pow(c2,2.0)-3.0*c2+1.0)/(6.0*std::pow(c2,2.0));
56 : : static const tk::real a22_impl = c2;
57 : : static const tk::real a21_expl = c2;
58 : : static const tk::real a32_expl = c3;
59 : : static const tk::real a33_impl =
60 : : (1.0/6.0-b2*std::pow(c2,2.0)-b3*c2*c3)/(b3*(c3-c2));
61 : : static const tk::real a32_impl = a33_impl-c3;
62 : : static const std::array< std::array< tk::real, 3 >, 2 >
63 : : expl_rkcoef{{ {{ 0.0, 0.0, b2 }},
64 : : {{ a21_expl, a32_expl, b3 }} }};
65 : : static const std::array< std::array< tk::real, 3 >, 2>
66 : : impl_rkcoef{{ {{ 0.0, a32_impl, b2 }},
67 : : {{ a22_impl, a33_impl, b3}} }};
68 : :
69 : : } // inciter::
70 : :
71 : : extern tk::CProxy_ChareStateCollector stateProxy;
72 : :
73 : : using inciter::DG;
74 : :
75 : 801 : DG::DG( const CProxy_Discretization& disc,
76 : : const CProxy_Ghosts& ghostsproxy,
77 : : const std::map< int, std::vector< std::size_t > >& bface,
78 : : const std::map< int, std::vector< std::size_t > >& /* bnode */,
79 : 801 : const std::vector< std::size_t >& triinpoel ) :
80 : : m_disc( disc ),
81 : : m_ghosts( ghostsproxy ),
82 : : m_ndof_NodalExtrm( 3 ), // for the first order derivatives in 3 directions
83 : : m_nsol( 0 ),
84 : : m_ninitsol( 0 ),
85 : : m_nlim( 0 ),
86 : : m_nnod( 0 ),
87 : : m_nrefine( 0 ),
88 : : m_nsmooth( 0 ),
89 : : m_nreco( 0 ),
90 : : m_nnodalExtrema( 0 ),
91 [ + - ]: 801 : m_nstiffeq( g_dgpde[Disc()->MeshId()].nstiffeq() ),
92 [ + - ]: 801 : m_nnonstiffeq( g_dgpde[Disc()->MeshId()].nnonstiffeq() ),
93 [ + - ]: 801 : m_u( Disc()->Inpoel().size()/4,
94 : 801 : g_inputdeck.get< tag::rdof >()*
95 : 801 : g_inputdeck.get< tag::ncomp >() ),
96 : : m_un( m_u.nunk(), m_u.nprop() ),
97 : 801 : m_p( m_u.nunk(), g_inputdeck.get< tag::rdof >()*
98 [ + - ][ + - ]: 801 : g_dgpde[Disc()->MeshId()].nprim() ),
99 : : m_lhs( m_u.nunk(),
100 : 801 : g_inputdeck.get< tag::ndof >()*
101 : 801 : g_inputdeck.get< tag::ncomp >() ),
102 : : m_rhs( m_u.nunk(), m_lhs.nprop() ),
103 : : m_rhsprev( m_u.nunk(), m_lhs.nprop() ),
104 : 801 : m_stiffrhs( m_u.nunk(), g_inputdeck.get< tag::ndof >()*
105 [ + - ][ + - ]: 801 : g_dgpde[Disc()->MeshId()].nstiffeq() ),
106 : 801 : m_stiffrhsprev( m_u.nunk(), g_inputdeck.get< tag::ndof >()*
107 [ + - ][ + - ]: 801 : g_dgpde[Disc()->MeshId()].nstiffeq() ),
108 [ + - ]: 801 : m_stiffEqIdx( g_dgpde[Disc()->MeshId()].nstiffeq() ),
109 [ + - ]: 801 : m_nonStiffEqIdx( g_dgpde[Disc()->MeshId()].nnonstiffeq() ),
110 : : m_mtInv(
111 : : tk::invMassMatTaylorRefEl(g_inputdeck.get< tag::rdof >()) ),
112 : : m_uNodalExtrm(),
113 : : m_pNodalExtrm(),
114 : : m_uNodalExtrmc(),
115 : : m_pNodalExtrmc(),
116 [ + - ]: 801 : m_npoin( Disc()->Coord()[0].size() ),
117 : : m_diag(),
118 : : m_stage( 0 ),
119 : : m_ndof(),
120 : : m_interface(),
121 : : m_numEqDof(),
122 : : m_uc(),
123 : : m_pc(),
124 : : m_ndofc(),
125 : : m_interfacec(),
126 : : m_initial( 1 ),
127 : : m_uElemfields( m_u.nunk(),
128 : : g_inputdeck.get< tag::ncomp >() ),
129 : : m_pElemfields( m_u.nunk(),
130 : 801 : m_p.nprop() / g_inputdeck.get< tag::rdof >() ),
131 : : m_uNodefields( m_npoin,
132 : : g_inputdeck.get< tag::ncomp >() ),
133 : : m_pNodefields( m_npoin,
134 : 801 : m_p.nprop() / g_inputdeck.get< tag::rdof >() ),
135 : : m_uNodefieldsc(),
136 : : m_pNodefieldsc(),
137 : : m_outmesh(),
138 : : m_boxelems(),
139 [ + - ][ + - ]: 8811 : m_shockmarker(m_u.nunk(), 1)
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ][ + - ]
[ + - ]
140 : : // *****************************************************************************
141 : : // Constructor
142 : : //! \param[in] disc Discretization proxy
143 : : //! \param[in] bface Boundary-faces mapped to side set ids
144 : : //! \param[in] triinpoel Boundary-face connectivity
145 : : // *****************************************************************************
146 : : {
147 [ + + ]: 801 : if (g_inputdeck.get< tag::cmd, tag::chare >() ||
148 [ + + ]: 763 : g_inputdeck.get< tag::cmd, tag::quiescence >())
149 [ + - ][ + - ]: 912 : stateProxy.ckLocalBranch()->insert( "DG", thisIndex, CkMyPe(), Disc()->It(),
[ + - ][ + - ]
[ - + ]
150 : : "DG" );
151 : :
152 : : // assign number of dofs for each equation in all pde systems
153 [ + - ][ + - ]: 801 : g_dgpde[Disc()->MeshId()].numEquationDofs(m_numEqDof);
154 : :
155 : : // Allocate storage for the vector of nodal extrema
156 [ + - ][ + - ]: 801 : m_uNodalExtrm.resize( Disc()->Bid().size(),
157 : 0 : std::vector<tk::real>( 2 * m_ndof_NodalExtrm *
158 [ + - ]: 801 : g_inputdeck.get< tag::ncomp >() ) );
159 [ + - ][ + - ]: 801 : m_pNodalExtrm.resize( Disc()->Bid().size(),
160 : 0 : std::vector<tk::real>( 2 * m_ndof_NodalExtrm *
161 [ + - ]: 801 : m_p.nprop() / g_inputdeck.get< tag::rdof >() ) );
162 : :
163 : : // Initialization for the buffer vector of nodal extrema
164 [ + - ]: 801 : resizeNodalExtremac();
165 : :
166 : 801 : usesAtSync = true; // enable migration at AtSync
167 : :
168 : : // Enable SDAG wait for initially building the solution vector and limiting
169 [ + - ]: 801 : if (m_initial) {
170 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4sol();
171 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4refine();
172 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4smooth();
173 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4lim();
174 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4nod();
175 [ + - ][ + - ]: 801 : thisProxy[ thisIndex ].wait4reco();
176 [ + - ][ + - ]: 1602 : thisProxy[ thisIndex ].wait4nodalExtrema();
177 : : }
178 : :
179 [ + - ][ + - ]: 1602 : m_ghosts[thisIndex].insert(m_disc, bface, triinpoel, m_u.nunk(),
180 [ + - ][ + - ]: 2403 : CkCallback(CkIndex_DG::resizeSolVectors(), thisProxy[thisIndex]));
[ - + ][ - + ]
[ - - ][ - - ]
181 : :
182 : : // global-sync to call doneInserting on m_ghosts
183 [ + - ]: 801 : auto meshid = Disc()->MeshId();
184 [ + - ]: 801 : contribute( sizeof(std::size_t), &meshid, CkReduction::nop,
185 [ + - ][ - - ]: 801 : CkCallback(CkReductionTarget(Transporter,doneInsertingGhosts),
186 [ + - ]: 801 : Disc()->Tr()) );
187 : 801 : }
188 : :
189 : : void
190 : 572 : DG::registerReducers()
191 : : // *****************************************************************************
192 : : // Configure Charm++ reduction types
193 : : //! \details Since this is a [initnode] routine, the runtime system executes the
194 : : //! routine exactly once on every logical node early on in the Charm++ init
195 : : //! sequence. Must be static as it is called without an object. See also:
196 : : //! Section "Initializations at Program Startup" at in the Charm++ manual
197 : : //! http://charm.cs.illinois.edu/manuals/html/charm++/manual.html.
198 : : // *****************************************************************************
199 : : {
200 : 572 : ElemDiagnostics::registerReducers();
201 : 572 : }
202 : :
203 : : void
204 : 17814 : DG::ResumeFromSync()
205 : : // *****************************************************************************
206 : : // Return from migration
207 : : //! \details This is called when load balancing (LB) completes. The presence of
208 : : //! this function does not affect whether or not we block on LB.
209 : : // *****************************************************************************
210 : : {
211 [ - + ][ - - ]: 17814 : if (Disc()->It() == 0) Throw( "it = 0 in ResumeFromSync()" );
[ - - ][ - - ]
[ - - ][ - - ]
[ - - ]
212 : :
213 [ + - ]: 17814 : if (!g_inputdeck.get< tag::cmd, tag::nonblocking >()) next();
214 : 17814 : }
215 : :
216 : : void
217 : 801 : DG::resizeSolVectors()
218 : : // *****************************************************************************
219 : : // Resize solution vectors after extension due to Ghosts and continue with setup
220 : : // *****************************************************************************
221 : : {
222 : : // Resize solution vectors, lhs and rhs by the number of ghost tets
223 : 801 : m_u.resize( myGhosts()->m_nunk );
224 : 801 : m_un.resize( myGhosts()->m_nunk );
225 : 801 : m_p.resize( myGhosts()->m_nunk );
226 : 801 : m_lhs.resize( myGhosts()->m_nunk );
227 : 801 : m_rhs.resize( myGhosts()->m_nunk );
228 : 801 : m_rhsprev.resize( myGhosts()->m_nunk );
229 : 801 : m_stiffrhs.resize( myGhosts()->m_nunk );
230 : 801 : m_stiffrhsprev.resize( myGhosts()->m_nunk );
231 : :
232 : : // Size communication buffer for solution and number of degrees of freedom
233 [ + + ]: 3204 : for (auto& n : m_ndofc) n.resize( myGhosts()->m_bid.size() );
234 [ + + ]: 3204 : for (auto& u : m_uc) u.resize( myGhosts()->m_bid.size() );
235 [ + + ]: 3204 : for (auto& p : m_pc) p.resize( myGhosts()->m_bid.size() );
236 [ + + ]: 1602 : for (auto& i : m_interfacec) i.resize( myGhosts()->m_bid.size() );
237 : :
238 : : // Initialize number of degrees of freedom in mesh elements
239 : 801 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
240 [ + + ]: 801 : if( pref )
241 : : {
242 : 134 : const auto ndofmax = g_inputdeck.get< tag::pref, tag::ndofmax >();
243 : 134 : m_ndof.resize( myGhosts()->m_nunk, ndofmax );
244 : : }
245 : : else
246 : : {
247 : 667 : const auto ndof = g_inputdeck.get< tag::ndof >();
248 : 667 : m_ndof.resize( myGhosts()->m_nunk, ndof );
249 : : }
250 : 801 : m_interface.resize( myGhosts()->m_nunk, 0 );
251 : :
252 : : // Ensure that we also have all the geometry and connectivity data
253 : : // (including those of ghosts)
254 : : Assert( myGhosts()->m_geoElem.nunk() == m_u.nunk(),
255 : : "GeoElem unknowns size mismatch" );
256 : :
257 : : // Signal the runtime system that all workers have received their adjacency
258 : 801 : std::vector< std::size_t > meshdata{ myGhosts()->m_initial, Disc()->MeshId() };
259 : 801 : contribute( meshdata, CkReduction::sum_ulong,
260 [ + - ][ + - ]: 2403 : CkCallback(CkReductionTarget(Transporter,comfinal), Disc()->Tr()) );
[ + - ][ - - ]
261 : 801 : }
262 : :
263 : : void
264 : 801 : DG::setup()
265 : : // *****************************************************************************
266 : : // Set initial conditions, generate lhs, output mesh
267 : : // *****************************************************************************
268 : : {
269 [ + + ]: 801 : if (g_inputdeck.get< tag::cmd, tag::chare >() ||
270 [ + + ]: 763 : g_inputdeck.get< tag::cmd, tag::quiescence >())
271 [ + - ][ + - ]: 912 : stateProxy.ckLocalBranch()->insert( "DG", thisIndex, CkMyPe(), Disc()->It(),
[ + - ][ + - ]
[ - + ]
272 : : "setup" );
273 : :
274 : 801 : auto d = Disc();
275 : :
276 : : // Basic error checking on sizes of element geometry data and connectivity
277 : : Assert( myGhosts()->m_geoElem.nunk() == m_lhs.nunk(),
278 : : "Size mismatch in DG::setup()" );
279 : :
280 : : // Compute left-hand side of discrete PDEs
281 : 801 : lhs();
282 : :
283 : : // Determine elements inside user-defined IC box
284 : 801 : g_dgpde[d->MeshId()].IcBoxElems( myGhosts()->m_geoElem,
285 : 801 : myGhosts()->m_fd.Esuel().size()/4, m_boxelems );
286 : :
287 : : // Compute volume of user-defined box IC
288 [ + - ][ - + ]: 801 : d->boxvol( {}, {}, 0 ); // punt for now
289 : :
290 : : // Query time history field output labels from all PDEs integrated
291 : : const auto& hist_points = g_inputdeck.get< tag::history_output, tag::point >();
292 [ - + ]: 801 : if (!hist_points.empty()) {
293 : 0 : std::vector< std::string > histnames;
294 [ - - ]: 0 : auto n = g_dgpde[d->MeshId()].histNames();
295 [ - - ]: 0 : histnames.insert( end(histnames), begin(n), end(n) );
296 [ - - ]: 0 : d->histheader( std::move(histnames) );
297 : : }
298 : :
299 : : // If working with IMEX-RK, Store stiff equations into m_stiffEqIdx
300 [ - + ]: 801 : if (g_inputdeck.get< tag::imex_runge_kutta >())
301 : : {
302 : 0 : g_dgpde[Disc()->MeshId()].setStiffEqIdx(m_stiffEqIdx);
303 : 0 : g_dgpde[Disc()->MeshId()].setNonStiffEqIdx(m_nonStiffEqIdx);
304 : : }
305 : 801 : }
306 : :
307 : : void
308 : 801 : DG::box( tk::real v, const std::vector< tk::real >& )
309 : : // *****************************************************************************
310 : : // Receive total box IC volume and set conditions in box
311 : : //! \param[in] v Total volume within user-specified box
312 : : // *****************************************************************************
313 : : {
314 : 801 : auto d = Disc();
315 : :
316 : : // Store user-defined box IC volume
317 : 801 : d->Boxvol() = v;
318 : :
319 : : // Set initial conditions for all PDEs
320 : 1602 : g_dgpde[d->MeshId()].initialize( m_lhs, myGhosts()->m_inpoel,
321 : 801 : myGhosts()->m_coord, m_boxelems, d->ElemBlockId(), m_u, d->T(),
322 : 801 : myGhosts()->m_fd.Esuel().size()/4 );
323 : 801 : g_dgpde[d->MeshId()].updatePrimitives( m_u, m_lhs, myGhosts()->m_geoElem, m_p,
324 : 801 : myGhosts()->m_fd.Esuel().size()/4, m_ndof );
325 : :
326 : : m_un = m_u;
327 : :
328 : : // Output initial conditions to file (regardless of whether it was requested)
329 [ + - ][ + - ]: 2403 : startFieldOutput( CkCallback(CkIndex_DG::start(), thisProxy[thisIndex]) );
[ - + ][ - - ]
330 : 801 : }
331 : :
332 : : void
333 : 801 : DG::start()
334 : : // *****************************************************************************
335 : : // Start time stepping
336 : : // *****************************************************************************
337 : : {
338 : : // Free memory storing output mesh
339 : 801 : m_outmesh.destroy();
340 : :
341 : : // Start timer measuring time stepping wall clock time
342 : 801 : Disc()->Timer().zero();
343 : : // Zero grind-timer
344 : 801 : Disc()->grindZero();
345 : : // Start time stepping by computing the size of the next time step)
346 : 801 : next();
347 : 801 : }
348 : :
349 : : void
350 : 22536 : DG::startFieldOutput( CkCallback c )
351 : : // *****************************************************************************
352 : : // Start preparing fields for output to file
353 : : //! \param[in] c Function to continue with after the write
354 : : // *****************************************************************************
355 : : {
356 : : // No field output in benchmark mode or if field output frequency not hit
357 [ + + ][ + + ]: 22536 : if (g_inputdeck.get< tag::cmd, tag::benchmark >() || !fieldOutput()) {
358 : :
359 : 20514 : c.send();
360 : :
361 : : } else {
362 : :
363 : : // Optionally refine mesh for field output
364 : 2022 : auto d = Disc();
365 : :
366 [ + + ]: 2022 : if (refinedOutput()) {
367 : :
368 : 33 : const auto& tr = tk::remap( myGhosts()->m_fd.Triinpoel(), d->Gid() );
369 [ + - ][ + - ]: 66 : d->Ref()->outref( myGhosts()->m_fd.Bface(), {}, tr, c );
[ + - ][ + - ]
[ - - ]
370 : :
371 : : } else {
372 : :
373 : : // cut off ghosts from mesh connectivity and coordinates
374 : 1989 : const auto& tr = tk::remap( myGhosts()->m_fd.Triinpoel(), d->Gid() );
375 [ + - ][ + - ]: 3978 : extractFieldOutput( {}, d->Chunk(), d->Coord(), {}, {},
[ + + ][ - - ]
376 [ + - ]: 1989 : d->NodeCommMap(), myGhosts()->m_fd.Bface(), {}, tr, c );
377 : :
378 : : }
379 : :
380 : : }
381 : 22536 : }
382 : :
383 : : void
384 : 65205 : DG::next()
385 : : // *****************************************************************************
386 : : // Advance equations to next time step
387 : : // *****************************************************************************
388 : : {
389 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
390 : :
391 : 65205 : auto d = Disc();
392 : :
393 [ + + ][ + + ]: 65205 : if (pref && m_stage == 0 && d->T() > 0)
[ + + ]
394 : 3272 : g_dgpde[d->MeshId()].eval_ndof( myGhosts()->m_nunk, myGhosts()->m_coord,
395 : 1636 : myGhosts()->m_inpoel,
396 : 1636 : myGhosts()->m_fd, m_u, m_p,
397 : : g_inputdeck.get< tag::pref, tag::indicator >(),
398 : : g_inputdeck.get< tag::ndof >(),
399 : : g_inputdeck.get< tag::pref, tag::ndofmax >(),
400 : : g_inputdeck.get< tag::pref, tag::tolref >(),
401 : 1636 : m_ndof );
402 : :
403 : : // communicate solution ghost data (if any)
404 [ + + ]: 65205 : if (myGhosts()->m_sendGhost.empty())
405 : 3780 : comsol_complete();
406 : : else
407 [ + + ]: 588060 : for(const auto& [cid, ghostdata] : myGhosts()->m_sendGhost) {
408 [ + - ]: 465210 : std::vector< std::size_t > tetid( ghostdata.size() );
409 [ + - ][ + - ]: 930420 : std::vector< std::vector< tk::real > > u( ghostdata.size() ),
[ - - ]
410 [ + - ][ + - ]: 930420 : prim( ghostdata.size() );
411 [ + - ][ + - ]: 465210 : std::vector< std::size_t > interface( ghostdata.size() );
412 [ + - ][ - - ]: 465210 : std::vector< std::size_t > ndof( ghostdata.size() );
413 : : std::size_t j = 0;
414 [ + + ]: 9179850 : for(const auto& i : ghostdata) {
415 : : Assert( i < myGhosts()->m_fd.Esuel().size()/4,
416 : : "Sending solution ghost data" );
417 [ + - ]: 8714640 : tetid[j] = i;
418 [ + - ][ - + ]: 8714640 : u[j] = m_u[i];
419 [ + - ][ - + ]: 8714640 : prim[j] = m_p[i];
420 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) {
421 : 395110 : ndof[j] = m_ndof[i];
422 : 395110 : interface[j] = m_interface[i];
423 : : }
424 : 8714640 : ++j;
425 : : }
426 [ + - ][ + - ]: 930420 : thisProxy[ cid ].comsol( thisIndex, m_stage, tetid, u, prim, interface, ndof );
[ + - ][ - - ]
427 : : }
428 : :
429 : 65205 : ownsol_complete();
430 : 65205 : }
431 : :
432 : : void
433 : 465210 : DG::comsol( int fromch,
434 : : std::size_t fromstage,
435 : : const std::vector< std::size_t >& tetid,
436 : : const std::vector< std::vector< tk::real > >& u,
437 : : const std::vector< std::vector< tk::real > >& prim,
438 : : const std::vector< std::size_t >& interface,
439 : : const std::vector< std::size_t >& ndof )
440 : : // *****************************************************************************
441 : : // Receive chare-boundary solution ghost data from neighboring chares
442 : : //! \param[in] fromch Sender chare id
443 : : //! \param[in] fromstage Sender chare time step stage
444 : : //! \param[in] tetid Ghost tet ids we receive solution data for
445 : : //! \param[in] u Solution ghost data
446 : : //! \param[in] prim Primitive variables in ghost cells
447 : : //! \param[in] interface Interface marker in ghost cells
448 : : //! \param[in] ndof Number of degrees of freedom for chare-boundary elements
449 : : //! \details This function receives contributions to the unlimited solution
450 : : //! from fellow chares.
451 : : // *****************************************************************************
452 : : {
453 : : Assert( u.size() == tetid.size(), "Size mismatch in DG::comsol()" );
454 : : Assert( prim.size() == tetid.size(), "Size mismatch in DG::comsol()" );
455 : :
456 : 465210 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
457 : :
458 : 465210 : if (pref && fromstage == 0) {
459 : : Assert( ndof.size() == tetid.size(), "Size mismatch in DG::comsol()" );
460 : : Assert( interface.size() == tetid.size(), "Size mismatch in DG::comsol()" );
461 : : }
462 : :
463 : : // Find local-to-ghost tet id map for sender chare
464 : 465210 : const auto& n = tk::cref_find( myGhosts()->m_ghost, fromch );
465 : :
466 [ + + ]: 9179850 : for (std::size_t i=0; i<tetid.size(); ++i) {
467 : 8714640 : auto j = tk::cref_find( n, tetid[i] );
468 : : Assert( j >= myGhosts()->m_fd.Esuel().size()/4,
469 : : "Receiving solution non-ghost data" );
470 : 8714640 : auto b = tk::cref_find( myGhosts()->m_bid, j );
471 : : Assert( b < m_uc[0].size(), "Indexing out of bounds" );
472 : 8714640 : m_uc[0][b] = u[i];
473 : 8714640 : m_pc[0][b] = prim[i];
474 [ + + ]: 8714640 : if (pref && fromstage == 0) {
475 : : Assert( b < m_ndofc[0].size(), "Indexing out of bounds" );
476 : 395110 : m_ndofc[0][b] = ndof[i];
477 : : Assert( b < m_interfacec[0].size(), "Indexing out of bounds" );
478 : 395110 : m_interfacec[0][b] = interface[i];
479 : : }
480 : : }
481 : :
482 : : // if we have received all solution ghost contributions from neighboring
483 : : // chares (chares we communicate along chare-boundary faces with), and
484 : : // contributed our solution to these neighbors, proceed to reconstructions
485 [ + + ]: 465210 : if (++m_nsol == myGhosts()->m_sendGhost.size()) {
486 : 61425 : m_nsol = 0;
487 : 61425 : comsol_complete();
488 : : }
489 : 465210 : }
490 : :
491 : : void
492 : 2022 : DG::extractFieldOutput(
493 : : const std::vector< std::size_t >& /*ginpoel*/,
494 : : const tk::UnsMesh::Chunk& chunk,
495 : : const tk::UnsMesh::Coords& coord,
496 : : const std::unordered_map< std::size_t, tk::UnsMesh::Edge >& /*addedNodes*/,
497 : : const std::unordered_map< std::size_t, std::size_t >& addedTets,
498 : : const tk::NodeCommMap& nodeCommMap,
499 : : const std::map< int, std::vector< std::size_t > >& bface,
500 : : const std::map< int, std::vector< std::size_t > >& /* bnode */,
501 : : const std::vector< std::size_t >& triinpoel,
502 : : CkCallback c )
503 : : // *****************************************************************************
504 : : // Extract field output going to file
505 : : //! \param[in] chunk Field-output mesh chunk (connectivity and global<->local
506 : : //! id maps)
507 : : //! \param[in] coord Field-output mesh node coordinates
508 : : //! \param[in] addedTets Field-output mesh cells and their parents (local ids)
509 : : //! \param[in] nodeCommMap Field-output mesh node communication map
510 : : //! \param[in] bface Field-output meshndary-faces mapped to side set ids
511 : : //! \param[in] triinpoel Field-output mesh boundary-face connectivity
512 : : //! \param[in] c Function to continue with after the write
513 : : // *****************************************************************************
514 : : {
515 : : m_outmesh.chunk = chunk;
516 : : m_outmesh.coord = coord;
517 : 2022 : m_outmesh.triinpoel = triinpoel;
518 : : m_outmesh.bface = bface;
519 : : m_outmesh.nodeCommMap = nodeCommMap;
520 : :
521 : : const auto& inpoel = std::get< 0 >( chunk );
522 : :
523 : : // Evaluate element solution on incoming mesh
524 : 2022 : evalSolution( *Disc(), inpoel, coord, addedTets, m_ndof, m_u, m_p,
525 : 2022 : m_uElemfields, m_pElemfields, m_uNodefields, m_pNodefields );
526 : :
527 : : // Send node fields contributions to neighbor chares
528 [ + + ]: 2022 : if (nodeCommMap.empty())
529 : 170 : comnodeout_complete();
530 : : else {
531 : : const auto& lid = std::get< 2 >( chunk );
532 : 3704 : auto esup = tk::genEsup( inpoel, 4 );
533 [ + + ]: 14462 : for(const auto& [ch,nodes] : nodeCommMap) {
534 : : // Pack node field data in chare boundary nodes
535 : : std::vector< std::vector< tk::real > >
536 [ + - ][ + - ]: 37830 : lu( m_uNodefields.nprop(), std::vector< tk::real >( nodes.size() ) );
[ + - ]
537 : : std::vector< std::vector< tk::real > >
538 [ + - ][ + - ]: 37830 : lp( m_pNodefields.nprop(), std::vector< tk::real >( nodes.size() ) );
539 [ + + ]: 60672 : for (std::size_t f=0; f<m_uNodefields.nprop(); ++f) {
540 : : std::size_t j = 0;
541 [ + + ]: 488060 : for (auto g : nodes)
542 : 439998 : lu[f][j++] = m_uNodefields(tk::cref_find(lid,g),f);
543 : : }
544 [ + + ]: 20126 : for (std::size_t f=0; f<m_pNodefields.nprop(); ++f) {
545 : : std::size_t j = 0;
546 [ + + ]: 80092 : for (auto g : nodes)
547 : 72576 : lp[f][j++] = m_pNodefields(tk::cref_find(lid,g),f);
548 : : }
549 : : // Pack (partial) number of elements surrounding chare boundary nodes
550 [ + - ]: 12610 : std::vector< std::size_t > nesup( nodes.size() );
551 : : std::size_t j = 0;
552 [ + + ]: 133974 : for (auto g : nodes) {
553 : 121364 : auto i = tk::cref_find( lid, g );
554 : 121364 : nesup[j++] = esup.second[i+1] - esup.second[i];
555 : : }
556 [ + - ][ + - ]: 37830 : thisProxy[ch].comnodeout(
[ + - ][ - - ]
557 [ + - ][ - + ]: 25220 : std::vector<std::size_t>(begin(nodes),end(nodes)), nesup, lu, lp );
558 : : }
559 : : }
560 : :
561 [ + - ]: 2022 : ownnod_complete( c, addedTets );
562 : 2022 : }
563 : :
564 : : void
565 : 801 : DG::lhs()
566 : : // *****************************************************************************
567 : : // Compute left-hand side of discrete transport equations
568 : : // *****************************************************************************
569 : : {
570 : 801 : g_dgpde[Disc()->MeshId()].lhs( myGhosts()->m_geoElem, m_lhs );
571 : :
572 [ - + ]: 801 : if (!m_initial) stage();
573 : 801 : }
574 : :
575 : 65205 : void DG::refine()
576 : : // *****************************************************************************
577 : : // Add the protective layer for ndof refinement
578 : : // *****************************************************************************
579 : : {
580 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
581 : :
582 : : // Combine own and communicated contributions of unreconstructed solution and
583 : : // degrees of freedom in cells (if p-adaptive)
584 [ + + ]: 8845050 : for (const auto& b : myGhosts()->m_bid) {
585 : : Assert( m_uc[0][b.second].size() == m_u.nprop(), "ncomp size mismatch" );
586 : : Assert( m_pc[0][b.second].size() == m_p.nprop(), "ncomp size mismatch" );
587 [ + + ]: 143651595 : for (std::size_t c=0; c<m_u.nprop(); ++c) {
588 : 134936955 : m_u(b.first,c) = m_uc[0][b.second][c];
589 : : }
590 [ + + ]: 28322865 : for (std::size_t c=0; c<m_p.nprop(); ++c) {
591 : 19608225 : m_p(b.first,c) = m_pc[0][b.second][c];
592 : : }
593 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) {
594 : 395110 : m_ndof[ b.first ] = m_ndofc[0][ b.second ];
595 : 395110 : m_interface[ b.first ] = m_interfacec[0][ b.second ];
596 : : }
597 : : }
598 : :
599 [ + + ][ + + ]: 65205 : if (pref && m_stage==0) refine_ndof();
600 : :
601 [ + + ]: 65205 : if (myGhosts()->m_sendGhost.empty())
602 : 3780 : comrefine_complete();
603 : : else
604 [ + + ]: 588060 : for(const auto& [cid, ghostdata] : myGhosts()->m_sendGhost) {
605 [ + - ]: 465210 : std::vector< std::size_t > tetid( ghostdata.size() );
606 [ + - ][ + - ]: 930420 : std::vector< std::vector< tk::real > > u( ghostdata.size() ),
[ - - ]
607 [ + - ][ + - ]: 930420 : prim( ghostdata.size() );
608 [ + - ]: 465210 : std::vector< std::size_t > ndof( ghostdata.size() );
609 : : std::size_t j = 0;
610 [ + + ]: 9179850 : for(const auto& i : ghostdata) {
611 : : Assert( i < myGhosts()->m_fd.Esuel().size()/4, "Sending refined ndof "
612 : : "data" );
613 [ + + ]: 8714640 : tetid[j] = i;
614 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) ndof[j] = m_ndof[i];
615 : 8714640 : ++j;
616 : : }
617 [ + - ][ + - ]: 930420 : thisProxy[ cid ].comrefine( thisIndex, tetid, ndof );
[ + - ][ - - ]
618 : : }
619 : :
620 : 65205 : ownrefine_complete();
621 : 65205 : }
622 : :
623 : : void
624 : 465210 : DG::comrefine( int fromch,
625 : : const std::vector< std::size_t >& tetid,
626 : : const std::vector< std::size_t >& ndof )
627 : : // *****************************************************************************
628 : : // Receive chare-boundary ghost data from neighboring chares
629 : : //! \param[in] fromch Sender chare id
630 : : //! \param[in] tetid Ghost tet ids we receive solution data for
631 : : //! \param[in] ndof Number of degrees of freedom for chare-boundary elements
632 : : //! \details This function receives contributions to the refined ndof data
633 : : //! from fellow chares.
634 : : // *****************************************************************************
635 : : {
636 : 465210 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
637 : :
638 : : if (pref && m_stage == 0)
639 : : Assert( ndof.size() == tetid.size(), "Size mismatch in DG::comrefine()" );
640 : :
641 : : // Find local-to-ghost tet id map for sender chare
642 : 465210 : const auto& n = tk::cref_find( myGhosts()->m_ghost, fromch );
643 : :
644 [ + + ]: 9179850 : for (std::size_t i=0; i<tetid.size(); ++i) {
645 : 8714640 : auto j = tk::cref_find( n, tetid[i] );
646 : : Assert( j >= myGhosts()->m_fd.Esuel().size()/4,
647 : : "Receiving solution non-ghost data" );
648 : 8714640 : auto b = tk::cref_find( myGhosts()->m_bid, j );
649 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) {
650 : : Assert( b < m_ndofc[1].size(), "Indexing out of bounds" );
651 : 395110 : m_ndofc[1][b] = ndof[i];
652 : : }
653 : : }
654 : :
655 : : // if we have received all solution ghost contributions from neighboring
656 : : // chares (chares we communicate along chare-boundary faces with), and
657 : : // contributed our solution to these neighbors, proceed to limiting
658 [ + + ]: 465210 : if (++m_nrefine == myGhosts()->m_sendGhost.size()) {
659 : 61425 : m_nrefine = 0;
660 : 61425 : comrefine_complete();
661 : : }
662 : 465210 : }
663 : :
664 : : void
665 : 65205 : DG::smooth()
666 : : // *****************************************************************************
667 : : // Smooth the refined ndof distribution
668 : : // *****************************************************************************
669 : : {
670 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
671 : :
672 [ + + ]: 8845050 : for (const auto& b : myGhosts()->m_bid) {
673 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0)
674 : 395110 : m_ndof[ b.first ] = m_ndofc[1][ b.second ];
675 : : }
676 : :
677 [ + + ][ + + ]: 65205 : if (pref && m_stage==0) smooth_ndof();
678 : :
679 [ + + ]: 65205 : if (myGhosts()->m_sendGhost.empty())
680 : 3780 : comsmooth_complete();
681 : : else
682 [ + + ]: 588060 : for(const auto& [cid, ghostdata] : myGhosts()->m_sendGhost) {
683 : 465210 : std::vector< std::size_t > tetid( ghostdata.size() );
684 : : std::vector< std::size_t > ndof;
685 : : std::size_t j = 0;
686 [ + + ]: 9179850 : for(const auto& i : ghostdata) {
687 : : Assert( i < myGhosts()->m_fd.Esuel().size()/4, "Sending ndof data" );
688 [ + + ]: 8714640 : tetid[j] = i;
689 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) ndof.push_back( m_ndof[i] );
[ + - ]
690 : 8714640 : ++j;
691 : : }
692 [ + - ][ + - ]: 930420 : thisProxy[ cid ].comsmooth( thisIndex, tetid, ndof );
[ + + ][ - - ]
693 : : }
694 : :
695 : 65205 : ownsmooth_complete();
696 : 65205 : }
697 : :
698 : : void
699 : 465210 : DG::comsmooth( int fromch,
700 : : const std::vector< std::size_t >& tetid,
701 : : const std::vector< std::size_t >& ndof )
702 : : // *****************************************************************************
703 : : // Receive chare-boundary ghost data from neighboring chares
704 : : //! \param[in] fromch Sender chare id
705 : : //! \param[in] tetid Ghost tet ids we receive solution data for
706 : : //! \param[in] ndof Number of degrees of freedom for chare-boundary elements
707 : : //! \details This function receives contributions to the smoothed ndof data
708 : : //! from fellow chares.
709 : : // *****************************************************************************
710 : : {
711 : 465210 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
712 : :
713 : : if (pref && m_stage == 0)
714 : : Assert( ndof.size() == tetid.size(), "Size mismatch in DG::comsmooth()" );
715 : :
716 : 465210 : const auto& n = tk::cref_find( myGhosts()->m_ghost, fromch );
717 : :
718 [ + + ]: 9179850 : for (std::size_t i=0; i<tetid.size(); ++i) {
719 : 8714640 : auto j = tk::cref_find( n, tetid[i] );
720 : : Assert( j >= myGhosts()->m_fd.Esuel().size()/4, "Receiving ndof data" );
721 : 8714640 : auto b = tk::cref_find( myGhosts()->m_bid, j );
722 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) {
723 : : Assert( b < m_ndofc[2].size(), "Indexing out of bounds" );
724 : 395110 : m_ndofc[2][b] = ndof[i];
725 : : }
726 : : }
727 : :
728 [ + + ]: 465210 : if (++m_nsmooth == myGhosts()->m_sendGhost.size()) {
729 : 61425 : m_nsmooth = 0;
730 : 61425 : comsmooth_complete();
731 : : }
732 : 465210 : }
733 : :
734 : : void
735 : 65205 : DG::reco()
736 : : // *****************************************************************************
737 : : // Compute reconstructions
738 : : // *****************************************************************************
739 : : {
740 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
741 : 65205 : const auto rdof = g_inputdeck.get< tag::rdof >();
742 : :
743 : : // Combine own and communicated contributions of unreconstructed solution and
744 : : // degrees of freedom in cells (if p-adaptive)
745 [ + + ]: 8845050 : for (const auto& b : myGhosts()->m_bid) {
746 [ + + ][ + + ]: 8714640 : if (pref && m_stage == 0) {
747 : 395110 : m_ndof[ b.first ] = m_ndofc[2][ b.second ];
748 : : }
749 : : }
750 : :
751 : 65205 : auto d = Disc();
752 [ + + ][ + + ]: 65205 : if (pref && m_stage==0) {
753 : 1770 : g_dgpde[d->MeshId()].resetAdapSol( myGhosts()->m_fd, m_u, m_p, m_ndof );
754 : : }
755 : :
756 [ + + ]: 65205 : if (rdof > 1)
757 : : // Reconstruct second-order solution and primitive quantities
758 : 74730 : g_dgpde[d->MeshId()].reconstruct( d->T(), myGhosts()->m_geoFace,
759 : 37365 : myGhosts()->m_geoElem,
760 : 37365 : myGhosts()->m_fd, myGhosts()->m_esup, myGhosts()->m_inpoel,
761 : 37365 : myGhosts()->m_coord, m_u, m_p, pref, m_ndof );
762 : :
763 : : // Send reconstructed solution to neighboring chares
764 [ + + ]: 65205 : if (myGhosts()->m_sendGhost.empty())
765 : 3780 : comreco_complete();
766 : : else
767 [ + + ]: 588060 : for(const auto& [cid, ghostdata] : myGhosts()->m_sendGhost) {
768 [ + - ]: 465210 : std::vector< std::size_t > tetid( ghostdata.size() );
769 [ + - ][ + - ]: 930420 : std::vector< std::vector< tk::real > > u( ghostdata.size() ),
[ - - ]
770 [ + - ]: 465210 : prim( ghostdata.size() );
771 : : std::size_t j = 0;
772 [ + + ]: 9179850 : for(const auto& i : ghostdata) {
773 : : Assert( i < myGhosts()->m_fd.Esuel().size()/4, "Sending reconstructed ghost "
774 : : "data" );
775 [ + - ]: 8714640 : tetid[j] = i;
776 [ + - ][ - + ]: 8714640 : u[j] = m_u[i];
777 [ + - ][ - + ]: 8714640 : prim[j] = m_p[i];
778 : 8714640 : ++j;
779 : : }
780 [ + - ][ + - ]: 930420 : thisProxy[ cid ].comreco( thisIndex, tetid, u, prim );
781 : : }
782 : :
783 : 65205 : ownreco_complete();
784 : 65205 : }
785 : :
786 : : void
787 : 465210 : DG::comreco( int fromch,
788 : : const std::vector< std::size_t >& tetid,
789 : : const std::vector< std::vector< tk::real > >& u,
790 : : const std::vector< std::vector< tk::real > >& prim )
791 : : // *****************************************************************************
792 : : // Receive chare-boundary reconstructed ghost data from neighboring chares
793 : : //! \param[in] fromch Sender chare id
794 : : //! \param[in] tetid Ghost tet ids we receive solution data for
795 : : //! \param[in] u Reconstructed high-order solution
796 : : //! \param[in] prim Limited high-order primitive quantities
797 : : //! \details This function receives contributions to the reconstructed solution
798 : : //! from fellow chares.
799 : : // *****************************************************************************
800 : : {
801 : : Assert( u.size() == tetid.size(), "Size mismatch in DG::comreco()" );
802 : : Assert( prim.size() == tetid.size(), "Size mismatch in DG::comreco()" );
803 : :
804 : : // Find local-to-ghost tet id map for sender chare
805 : 465210 : const auto& n = tk::cref_find( myGhosts()->m_ghost, fromch );
806 : :
807 [ + + ]: 9179850 : for (std::size_t i=0; i<tetid.size(); ++i) {
808 : 8714640 : auto j = tk::cref_find( n, tetid[i] );
809 : : Assert( j >= myGhosts()->m_fd.Esuel().size()/4,
810 : : "Receiving solution non-ghost data" );
811 : 8714640 : auto b = tk::cref_find( myGhosts()->m_bid, j );
812 : : Assert( b < m_uc[1].size(), "Indexing out of bounds" );
813 : : Assert( b < m_pc[1].size(), "Indexing out of bounds" );
814 : 8714640 : m_uc[1][b] = u[i];
815 : 8714640 : m_pc[1][b] = prim[i];
816 : : }
817 : :
818 : : // if we have received all solution ghost contributions from neighboring
819 : : // chares (chares we communicate along chare-boundary faces with), and
820 : : // contributed our solution to these neighbors, proceed to limiting
821 [ + + ]: 465210 : if (++m_nreco == myGhosts()->m_sendGhost.size()) {
822 : 61425 : m_nreco = 0;
823 : 61425 : comreco_complete();
824 : : }
825 : 465210 : }
826 : :
827 : : void
828 : 65205 : DG::nodalExtrema()
829 : : // *****************************************************************************
830 : : // Compute nodal extrema at chare-boundary nodes. Extrema at internal nodes
831 : : // are calculated in limiter function.
832 : : // *****************************************************************************
833 : : {
834 : 65205 : auto d = Disc();
835 : 65205 : auto gid = d->Gid();
836 : : auto bid = d->Bid();
837 : 65205 : const auto rdof = g_inputdeck.get< tag::rdof >();
838 : 65205 : const auto ncomp = m_u.nprop() / rdof;
839 : 65205 : const auto nprim = m_p.nprop() / rdof;
840 : :
841 : : // Combine own and communicated contributions of unlimited solution, and
842 : : // if a p-adaptive algorithm is used, degrees of freedom in cells
843 [ + - ][ + + ]: 8845050 : for (const auto& [boundary, localtet] : myGhosts()->m_bid) {
844 : : Assert( m_uc[1][localtet].size() == m_u.nprop(), "ncomp size mismatch" );
845 : : Assert( m_pc[1][localtet].size() == m_p.nprop(), "ncomp size mismatch" );
846 [ + + ]: 143651595 : for (std::size_t c=0; c<m_u.nprop(); ++c) {
847 : 134936955 : m_u(boundary,c) = m_uc[1][localtet][c];
848 : : }
849 [ + + ]: 28322865 : for (std::size_t c=0; c<m_p.nprop(); ++c) {
850 : 19608225 : m_p(boundary,c) = m_pc[1][localtet][c];
851 : : }
852 : : }
853 : :
854 : : // Initialize nodal extrema vector
855 : : auto large = std::numeric_limits< tk::real >::max();
856 [ + + ]: 2116455 : for(std::size_t i = 0; i<bid.size(); i++)
857 : : {
858 [ + + ]: 7699440 : for (std::size_t c=0; c<ncomp; ++c)
859 : : {
860 [ + + ]: 22592760 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
861 : : {
862 : 16944570 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
863 : 16944570 : auto min_mark = max_mark + 1;
864 : 16944570 : m_uNodalExtrm[i][max_mark] = -large;
865 : 16944570 : m_uNodalExtrm[i][min_mark] = large;
866 : : }
867 : : }
868 [ + + ]: 3180900 : for (std::size_t c=0; c<nprim; ++c)
869 : : {
870 [ + + ]: 4518600 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
871 : : {
872 : 3388950 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
873 : 3388950 : auto min_mark = max_mark + 1;
874 : 3388950 : m_pNodalExtrm[i][max_mark] = -large;
875 : 3388950 : m_pNodalExtrm[i][min_mark] = large;
876 : : }
877 : : }
878 : : }
879 : :
880 : : // Evaluate the max/min value for the chare-boundary nodes
881 [ + + ]: 65205 : if(rdof > 4) {
882 [ + - ]: 14970 : evalNodalExtrmRefEl(ncomp, nprim, m_ndof_NodalExtrm, d->bndel(),
883 [ + - ][ + - ]: 7485 : myGhosts()->m_inpoel, gid, bid, m_u, m_p, m_uNodalExtrm, m_pNodalExtrm);
884 : : }
885 : :
886 : : // Communicate extrema at nodes to other chares on chare-boundary
887 [ + + ]: 65205 : if (d->NodeCommMap().empty()) // in serial we are done
888 [ + - ]: 3780 : comnodalExtrema_complete();
889 : : else // send nodal extrema to chare-boundary nodes to fellow chares
890 : : {
891 [ + + ]: 526635 : for (const auto& [c,n] : d->NodeCommMap()) {
892 [ + - ][ + - ]: 930420 : std::vector< std::vector< tk::real > > g1( n.size() ), g2( n.size() );
893 : : std::size_t j = 0;
894 [ + + ]: 3864900 : for (auto i : n)
895 : : {
896 : 3399690 : auto p = tk::cref_find(d->Bid(),i);
897 [ + - ]: 3399690 : g1[ j ] = m_uNodalExtrm[ p ];
898 [ + - ]: 3399690 : g2[ j++ ] = m_pNodalExtrm[ p ];
899 : : }
900 [ + - ][ + - ]: 930420 : thisProxy[c].comnodalExtrema( std::vector<std::size_t>(begin(n),end(n)),
[ + - ][ - + ]
901 : : g1, g2 );
902 : : }
903 : : }
904 [ + - ]: 65205 : ownnodalExtrema_complete();
905 : 65205 : }
906 : :
907 : : void
908 : 465210 : DG::comnodalExtrema( const std::vector< std::size_t >& gid,
909 : : const std::vector< std::vector< tk::real > >& G1,
910 : : const std::vector< std::vector< tk::real > >& G2 )
911 : : // *****************************************************************************
912 : : // Receive contributions to nodal extrema on chare-boundaries
913 : : //! \param[in] gid Global mesh node IDs at which we receive grad contributions
914 : : //! \param[in] G1 Partial contributions of extrema for conservative variables to
915 : : //! chare-boundary nodes
916 : : //! \param[in] G2 Partial contributions of extrema for primitive variables to
917 : : //! chare-boundary nodes
918 : : //! \details This function receives contributions to m_uNodalExtrm/m_pNodalExtrm
919 : : //! , which stores nodal extrems at mesh chare-boundary nodes. While
920 : : //! m_uNodalExtrm/m_pNodalExtrm stores own contributions, m_uNodalExtrmc
921 : : //! /m_pNodalExtrmc collects the neighbor chare contributions during
922 : : //! communication.
923 : : // *****************************************************************************
924 : : {
925 : : Assert( G1.size() == gid.size(), "Size mismatch" );
926 : : Assert( G2.size() == gid.size(), "Size mismatch" );
927 : :
928 : 465210 : const auto rdof = g_inputdeck.get< tag::rdof >();
929 : 465210 : const auto ncomp = m_u.nprop() / rdof;
930 : 465210 : const auto nprim = m_p.nprop() / rdof;
931 : :
932 [ + + ]: 3864900 : for (std::size_t i=0; i<gid.size(); ++i)
933 : : {
934 : : auto& u = m_uNodalExtrmc[gid[i]];
935 : 3399690 : auto& p = m_pNodalExtrmc[gid[i]];
936 [ + + ]: 14644440 : for (std::size_t c=0; c<ncomp; ++c)
937 : : {
938 [ + + ]: 44979000 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
939 : : {
940 : 33734250 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
941 : 33734250 : auto min_mark = max_mark + 1;
942 [ + + ][ + + ]: 34282679 : u[max_mark] = std::max( G1[i][max_mark], u[max_mark] );
943 : 33734250 : u[min_mark] = std::min( G1[i][min_mark], u[min_mark] );
944 : : }
945 : : }
946 [ + + ]: 6102240 : for (std::size_t c=0; c<nprim; ++c)
947 : : {
948 [ + + ]: 10810200 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
949 : : {
950 : 8107650 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
951 : 8107650 : auto min_mark = max_mark + 1;
952 [ - + ][ - + ]: 8107650 : p[max_mark] = std::max( G2[i][max_mark], p[max_mark] );
953 : 8107650 : p[min_mark] = std::min( G2[i][min_mark], p[min_mark] );
954 : : }
955 : : }
956 : : }
957 : :
958 [ + + ]: 465210 : if (++m_nnodalExtrema == Disc()->NodeCommMap().size())
959 : : {
960 : 61425 : m_nnodalExtrema = 0;
961 : 61425 : comnodalExtrema_complete();
962 : : }
963 : 465210 : }
964 : :
965 : 66006 : void DG::resizeNodalExtremac()
966 : : // *****************************************************************************
967 : : // Resize the buffer vector of nodal extrema
968 : : // *****************************************************************************
969 : : {
970 : 66006 : const auto rdof = g_inputdeck.get< tag::rdof >();
971 : 66006 : const auto ncomp = m_u.nprop() / rdof;
972 : 66006 : const auto nprim = m_p.nprop() / rdof;
973 : :
974 : 66006 : auto large = std::numeric_limits< tk::real >::max();
975 [ + - ][ + + ]: 604254 : for (const auto& [c,n] : Disc()->NodeCommMap())
976 : : {
977 [ + + ][ + - ]: 3917506 : for (auto i : n) {
978 : : auto& u = m_uNodalExtrmc[i];
979 : : auto& p = m_pNodalExtrmc[i];
980 [ + - ]: 3445264 : u.resize( 2*m_ndof_NodalExtrm*ncomp, large );
981 [ + - ]: 3445264 : p.resize( 2*m_ndof_NodalExtrm*nprim, large );
982 : :
983 : : // Initialize the minimum nodal extrema
984 [ + + ]: 13781056 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
985 : : {
986 [ + + ]: 44531526 : for(std::size_t k = 0; k < ncomp; k++)
987 : 34195734 : u[2*k*m_ndof_NodalExtrm+2*idof] = -large;
988 [ + + ]: 18547188 : for(std::size_t k = 0; k < nprim; k++)
989 : 8211396 : p[2*k*m_ndof_NodalExtrm+2*idof] = -large;
990 : : }
991 : : }
992 : : }
993 : 66006 : }
994 : :
995 : 7485 : void DG::evalNodalExtrmRefEl(
996 : : const std::size_t ncomp,
997 : : const std::size_t nprim,
998 : : const std::size_t ndof_NodalExtrm,
999 : : const std::vector< std::size_t >& bndel,
1000 : : const std::vector< std::size_t >& inpoel,
1001 : : const std::vector< std::size_t >& gid,
1002 : : const std::unordered_map< std::size_t, std::size_t >& bid,
1003 : : const tk::Fields& U,
1004 : : const tk::Fields& P,
1005 : : std::vector< std::vector<tk::real> >& uNodalExtrm,
1006 : : std::vector< std::vector<tk::real> >& pNodalExtrm )
1007 : : // *****************************************************************************
1008 : : // Compute the nodal extrema of ref el derivatives for chare-boundary nodes
1009 : : //! \param[in] ncomp Number of conservative variables
1010 : : //! \param[in] nprim Number of primitive variables
1011 : : //! \param[in] ndof_NodalExtrm Degree of freedom for nodal extrema
1012 : : //! \param[in] bndel List of elements contributing to chare-boundary nodes
1013 : : //! \param[in] inpoel Element-node connectivity for element e
1014 : : //! \param[in] gid Local->global node id map
1015 : : //! \param[in] bid Local chare-boundary node ids (value) associated to
1016 : : //! global node ids (key)
1017 : : //! \param[in] U Vector of conservative variables
1018 : : //! \param[in] P Vector of primitive variables
1019 : : //! \param[in,out] uNodalExtrm Chare-boundary nodal extrema for conservative
1020 : : //! variables
1021 : : //! \param[in,out] pNodalExtrm Chare-boundary nodal extrema for primitive
1022 : : //! variables
1023 : : // *****************************************************************************
1024 : : {
1025 : 7485 : const auto rdof = g_inputdeck.get< tag::rdof >();
1026 : :
1027 [ + + ]: 702165 : for (auto e : bndel)
1028 : : {
1029 : : // access node IDs
1030 : : const std::vector<std::size_t> N
1031 [ + - ]: 694680 : { inpoel[e*4+0], inpoel[e*4+1], inpoel[e*4+2], inpoel[e*4+3] };
1032 : :
1033 : : // Loop over nodes of element e
1034 [ + + ]: 3473400 : for(std::size_t ip=0; ip<4; ++ip)
1035 : : {
1036 : 2778720 : auto i = bid.find( gid[N[ip]] );
1037 [ + + ]: 2778720 : if (i != end(bid)) // If ip is the chare boundary point
1038 : : {
1039 : : // If DG(P2) is applied, find the nodal extrema of the gradients of
1040 : : // conservative/primitive variables in the reference element
1041 : :
1042 : : // Vector used to store the first order derivatives for both
1043 : : // conservative and primitive variables
1044 [ + - ][ - - ]: 1861455 : std::vector< std::array< tk::real, 3 > > gradc(ncomp, {0.0, 0.0, 0.0});
1045 [ + - ][ - - ]: 1861455 : std::vector< std::array< tk::real, 3 > > gradp(ncomp, {0.0, 0.0, 0.0});
1046 : :
1047 : : // Derivatives of the Dubiner basis
1048 : 1861455 : std::array< tk::real, 3 > center {{0.25, 0.25, 0.25}};
1049 [ + - ]: 1861455 : auto dBdxi = tk::eval_dBdxi(rdof, center);
1050 : :
1051 : : // Evaluate the first order derivative
1052 [ + + ]: 10741830 : for(std::size_t icomp = 0; icomp < ncomp; icomp++)
1053 : : {
1054 : 8880375 : auto mark = icomp * rdof;
1055 [ + + ]: 35521500 : for(std::size_t idir = 0; idir < 3; idir++)
1056 : : {
1057 : 26641125 : gradc[icomp][idir] = 0;
1058 [ + + ]: 266411250 : for(std::size_t idof = 1; idof < rdof; idof++)
1059 : 239770125 : gradc[icomp][idir] += U(e, mark+idof) * dBdxi[idir][idof];
1060 : : }
1061 : : }
1062 [ - + ]: 1861455 : for(std::size_t icomp = 0; icomp < nprim; icomp++)
1063 : : {
1064 : 0 : auto mark = icomp * rdof;
1065 [ - - ]: 0 : for(std::size_t idir = 0; idir < 3; idir++)
1066 : : {
1067 : 0 : gradp[icomp][idir] = 0;
1068 [ - - ]: 0 : for(std::size_t idof = 1; idof < rdof; idof++)
1069 : 0 : gradp[icomp][idir] += P(e, mark+idof) * dBdxi[idir][idof];
1070 : : }
1071 : : }
1072 : :
1073 : : // Store the extrema for the gradients
1074 [ + + ]: 10741830 : for (std::size_t c=0; c<ncomp; ++c)
1075 : : {
1076 [ + + ]: 35521500 : for (std::size_t idof = 0; idof < ndof_NodalExtrm; idof++)
1077 : : {
1078 : 26641125 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
1079 : 26641125 : auto min_mark = max_mark + 1;
1080 [ + + ]: 26641125 : auto& ex = uNodalExtrm[i->second];
1081 [ + + ][ + + ]: 33419895 : ex[max_mark] = std::max(ex[max_mark], gradc[c][idof]);
1082 : 26641125 : ex[min_mark] = std::min(ex[min_mark], gradc[c][idof]);
1083 : : }
1084 : : }
1085 [ - + ]: 1861455 : for (std::size_t c=0; c<nprim; ++c)
1086 : : {
1087 [ - - ]: 0 : for (std::size_t idof = 0; idof < ndof_NodalExtrm; idof++)
1088 : : {
1089 : 0 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
1090 : 0 : auto min_mark = max_mark + 1;
1091 [ - - ]: 0 : auto& ex = pNodalExtrm[i->second];
1092 [ - - ][ - - ]: 0 : ex[max_mark] = std::max(ex[max_mark], gradp[c][idof]);
1093 : 0 : ex[min_mark] = std::min(ex[min_mark], gradp[c][idof]);
1094 : : }
1095 : : }
1096 : : }
1097 : : }
1098 : : }
1099 : 7485 : }
1100 : :
1101 : : void
1102 : 65205 : DG::lim()
1103 : : // *****************************************************************************
1104 : : // Compute limiter function
1105 : : // *****************************************************************************
1106 : : {
1107 : 65205 : auto d = Disc();
1108 : 65205 : const auto rdof = g_inputdeck.get< tag::rdof >();
1109 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
1110 : 65205 : const auto ncomp = m_u.nprop() / rdof;
1111 : 65205 : const auto nprim = m_p.nprop() / rdof;
1112 : :
1113 : : // Combine own and communicated contributions to nodal extrema
1114 [ + + ]: 2116455 : for (const auto& [gid,g] : m_uNodalExtrmc) {
1115 : 2051250 : auto bid = tk::cref_find( d->Bid(), gid );
1116 [ + + ]: 7699440 : for (ncomp_t c=0; c<ncomp; ++c)
1117 : : {
1118 [ + + ]: 22592760 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
1119 : : {
1120 : 16944570 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
1121 : 16944570 : auto min_mark = max_mark + 1;
1122 : 16944570 : m_uNodalExtrm[bid][max_mark] =
1123 [ + + ][ + + ]: 17691182 : std::max(g[max_mark], m_uNodalExtrm[bid][max_mark]);
1124 : 16944570 : m_uNodalExtrm[bid][min_mark] =
1125 : 16944570 : std::min(g[min_mark], m_uNodalExtrm[bid][min_mark]);
1126 : : }
1127 : : }
1128 : : }
1129 [ + + ]: 2116455 : for (const auto& [gid,g] : m_pNodalExtrmc) {
1130 : 2051250 : auto bid = tk::cref_find( d->Bid(), gid );
1131 [ + + ]: 3180900 : for (ncomp_t c=0; c<nprim; ++c)
1132 : : {
1133 [ + + ]: 4518600 : for(std::size_t idof=0; idof<m_ndof_NodalExtrm; idof++)
1134 : : {
1135 : 3388950 : auto max_mark = 2*c*m_ndof_NodalExtrm + 2*idof;
1136 : 3388950 : auto min_mark = max_mark + 1;
1137 : 3388950 : m_pNodalExtrm[bid][max_mark] =
1138 [ - + ][ - + ]: 3388950 : std::max(g[max_mark], m_pNodalExtrm[bid][max_mark]);
1139 : 3388950 : m_pNodalExtrm[bid][min_mark] =
1140 : 3388950 : std::min(g[min_mark], m_pNodalExtrm[bid][min_mark]);
1141 : : }
1142 : : }
1143 : : }
1144 : :
1145 : : // clear gradients receive buffer
1146 : 65205 : tk::destroy(m_uNodalExtrmc);
1147 : 65205 : tk::destroy(m_pNodalExtrmc);
1148 : :
1149 [ + + ]: 65205 : if (rdof > 1) {
1150 : 74730 : g_dgpde[d->MeshId()].limit( d->T(), pref, myGhosts()->m_geoFace,
1151 : 37365 : myGhosts()->m_geoElem, myGhosts()->m_fd, myGhosts()->m_esup,
1152 : 37365 : myGhosts()->m_inpoel, myGhosts()->m_coord, m_ndof, d->Gid(),
1153 : 37365 : d->Bid(), m_uNodalExtrm, m_pNodalExtrm, m_mtInv, m_u, m_p,
1154 : 37365 : m_shockmarker );
1155 : :
1156 [ + + ]: 37365 : if (g_inputdeck.get< tag::limsol_projection >())
1157 : 66630 : g_dgpde[d->MeshId()].CPL(m_p, myGhosts()->m_geoElem,
1158 : 33315 : myGhosts()->m_inpoel, myGhosts()->m_coord, m_u,
1159 : 33315 : myGhosts()->m_fd.Esuel().size()/4);
1160 : : }
1161 : :
1162 : : // Send limited solution to neighboring chares
1163 [ + + ]: 65205 : if (myGhosts()->m_sendGhost.empty())
1164 : 3780 : comlim_complete();
1165 : : else
1166 [ + + ]: 588060 : for(const auto& [cid, ghostdata] : myGhosts()->m_sendGhost) {
1167 [ + - ]: 465210 : std::vector< std::size_t > tetid( ghostdata.size() );
1168 [ + - ][ + - ]: 930420 : std::vector< std::vector< tk::real > > u( ghostdata.size() ),
[ - - ]
1169 [ + - ]: 465210 : prim( ghostdata.size() );
1170 : : std::vector< std::size_t > ndof;
1171 : : std::size_t j = 0;
1172 [ + + ]: 9179850 : for(const auto& i : ghostdata) {
1173 : : Assert( i < myGhosts()->m_fd.Esuel().size()/4,
1174 : : "Sending limiter ghost data" );
1175 [ + - ]: 8714640 : tetid[j] = i;
1176 [ + - ][ - + ]: 8714640 : u[j] = m_u[i];
1177 [ + - ][ - + ]: 8714640 : prim[j] = m_p[i];
1178 : 8714640 : ++j;
1179 : : }
1180 [ + - ][ + - ]: 930420 : thisProxy[ cid ].comlim( thisIndex, tetid, u, prim );
1181 : : }
1182 : :
1183 : 65205 : ownlim_complete();
1184 : 65205 : }
1185 : :
1186 : : void
1187 : 1770 : DG::refine_ndof()
1188 : : // *****************************************************************************
1189 : : // p-refine all elements that are adjacent to p-refined elements
1190 : : //! \details This function p-refines all the neighbors of an element that has
1191 : : //! been p-refined as a result of an error indicator.
1192 : : // *****************************************************************************
1193 : : {
1194 : 1770 : auto d = Disc();
1195 : : const auto& coord = d->Coord();
1196 : 1770 : const auto& inpoel = d->Inpoel();
1197 : 1770 : const auto npoin = coord[0].size();
1198 : 1770 : const auto nelem = myGhosts()->m_fd.Esuel().size()/4;
1199 : 1770 : std::vector<std::size_t> node_ndof(npoin, 1);
1200 : :
1201 : : // Mark the max ndof for each node and store in node_ndof
1202 [ + + ]: 188540 : for(std::size_t ip=0; ip<npoin; ip++)
1203 : : {
1204 [ + - ]: 186770 : const auto& pesup = tk::cref_find(myGhosts()->m_esup, ip);
1205 [ + + ]: 2641810 : for(auto er : pesup)
1206 [ + + ]: 2537044 : node_ndof[ip] = std::max(m_ndof[er], node_ndof[ip]);
1207 : : }
1208 : :
1209 [ + + ]: 414490 : for(std::size_t e = 0; e < nelem; e++)
1210 : : {
1211 : : // Find if any node of this element has p1/p2 ndofs
1212 : : std::size_t counter_p2(0);
1213 : : std::size_t counter_p1(0);
1214 [ + + ]: 2063600 : for(std::size_t inode = 0; inode < 4; inode++)
1215 : : {
1216 [ + + ]: 1650880 : auto node = inpoel[4*e+inode];
1217 [ + + ]: 1650880 : if(node_ndof[node] == 10)
1218 : 320808 : counter_p2++;
1219 [ + + ]: 1330072 : else if (node_ndof[node] == 4)
1220 : 180140 : counter_p1++;
1221 : : }
1222 : :
1223 : : // If there is at least one node with p1/p2 ndofs, all of the elements
1224 : : // around this node are refined to p1/p2.
1225 [ + + ][ + + ]: 412720 : if(counter_p2 > 0 && m_ndof[e] < 10)
1226 : : {
1227 [ + + ]: 16717 : if(m_ndof[e] == 4)
1228 : 15693 : m_ndof[e] = 10;
1229 [ + + ]: 16717 : if(m_ndof[e] == 1)
1230 : 1024 : m_ndof[e] = 4;
1231 : : }
1232 [ + + ][ + + ]: 396003 : else if(counter_p1 > 0 && m_ndof[e] < 4)
1233 : 13452 : m_ndof[e] = 4;
1234 : : }
1235 : 1770 : }
1236 : :
1237 : 1770 : void DG::smooth_ndof()
1238 : : // *****************************************************************************
1239 : : // Smooth the refined ndof distribution to avoid zigzag refinement
1240 : : // *****************************************************************************
1241 : : {
1242 : 1770 : auto d = Disc();
1243 : 1770 : const auto& inpoel = d->Inpoel();
1244 : : const auto& coord = d->Coord();
1245 : 1770 : const auto npoin = coord[0].size();
1246 : 1770 : const auto nelem = myGhosts()->m_fd.Esuel().size()/4;
1247 : 1770 : std::vector<std::size_t> node_ndof(npoin, 1);
1248 : :
1249 : : // Mark the max ndof for each node and store in node_ndof
1250 [ + + ]: 188540 : for(std::size_t ip=0; ip<npoin; ip++)
1251 : : {
1252 [ + - ]: 186770 : const auto& pesup = tk::cref_find(myGhosts()->m_esup, ip);
1253 [ + + ]: 2641810 : for(auto er : pesup)
1254 [ + + ]: 2542705 : node_ndof[ip] = std::max(m_ndof[er], node_ndof[ip]);
1255 : : }
1256 : :
1257 [ + + ]: 414490 : for(std::size_t e = 0; e < nelem; e++)
1258 : : {
1259 : : // Find if any node of this element has p1/p2 ndofs
1260 : : std::size_t counter_p2(0);
1261 : : std::size_t counter_p1(0);
1262 [ + + ]: 2063600 : for(std::size_t inode = 0; inode < 4; inode++)
1263 : : {
1264 [ + + ]: 1650880 : auto node = inpoel[4*e+inode];
1265 [ + + ]: 1650880 : if(node_ndof[node] == 10)
1266 : 382503 : counter_p2++;
1267 [ + + ]: 1268377 : else if (node_ndof[node] == 4)
1268 : 182564 : counter_p1++;
1269 : : }
1270 : :
1271 : : // If all the nodes in the element are p1/p2, this element is refined to
1272 : : // p1/p2.
1273 [ + + ][ + + ]: 412720 : if(counter_p2 == 4 && m_ndof[e] == 4)
1274 : 1469 : m_ndof[e] = 10;
1275 [ + + ][ + + ]: 411251 : else if(counter_p1 == 4 && m_ndof[e] == 1)
1276 : 1553 : m_ndof[e] = 4;
1277 : : }
1278 : 1770 : }
1279 : :
1280 : : void
1281 : 465210 : DG::comlim( int fromch,
1282 : : const std::vector< std::size_t >& tetid,
1283 : : const std::vector< std::vector< tk::real > >& u,
1284 : : const std::vector< std::vector< tk::real > >& prim )
1285 : : // *****************************************************************************
1286 : : // Receive chare-boundary limiter ghost data from neighboring chares
1287 : : //! \param[in] fromch Sender chare id
1288 : : //! \param[in] tetid Ghost tet ids we receive solution data for
1289 : : //! \param[in] u Limited high-order solution
1290 : : //! \param[in] prim Limited high-order primitive quantities
1291 : : //! \details This function receives contributions to the limited solution from
1292 : : //! fellow chares.
1293 : : // *****************************************************************************
1294 : : {
1295 : : Assert( u.size() == tetid.size(), "Size mismatch in DG::comlim()" );
1296 : : Assert( prim.size() == tetid.size(), "Size mismatch in DG::comlim()" );
1297 : :
1298 : : // Find local-to-ghost tet id map for sender chare
1299 : 465210 : const auto& n = tk::cref_find( myGhosts()->m_ghost, fromch );
1300 : :
1301 [ + + ]: 9179850 : for (std::size_t i=0; i<tetid.size(); ++i) {
1302 : 8714640 : auto j = tk::cref_find( n, tetid[i] );
1303 : : Assert( j >= myGhosts()->m_fd.Esuel().size()/4,
1304 : : "Receiving solution non-ghost data" );
1305 : 8714640 : auto b = tk::cref_find( myGhosts()->m_bid, j );
1306 : : Assert( b < m_uc[2].size(), "Indexing out of bounds" );
1307 : : Assert( b < m_pc[2].size(), "Indexing out of bounds" );
1308 : 8714640 : m_uc[2][b] = u[i];
1309 : 8714640 : m_pc[2][b] = prim[i];
1310 : : }
1311 : :
1312 : : // if we have received all solution ghost contributions from neighboring
1313 : : // chares (chares we communicate along chare-boundary faces with), and
1314 : : // contributed our solution to these neighbors, proceed to limiting
1315 [ + + ]: 465210 : if (++m_nlim == myGhosts()->m_sendGhost.size()) {
1316 : 61425 : m_nlim = 0;
1317 : 61425 : comlim_complete();
1318 : : }
1319 : 465210 : }
1320 : :
1321 : : void
1322 : 65205 : DG::dt()
1323 : : // *****************************************************************************
1324 : : // Compute time step size
1325 : : // *****************************************************************************
1326 : : {
1327 : 65205 : auto d = Disc();
1328 : :
1329 : : // Combine own and communicated contributions of limited solution and degrees
1330 : : // of freedom in cells (if p-adaptive)
1331 [ + + ]: 8845050 : for (const auto& b : myGhosts()->m_bid) {
1332 : : Assert( m_uc[2][b.second].size() == m_u.nprop(), "ncomp size mismatch" );
1333 : : Assert( m_pc[2][b.second].size() == m_p.nprop(), "ncomp size mismatch" );
1334 [ + + ]: 143651595 : for (std::size_t c=0; c<m_u.nprop(); ++c) {
1335 : 134936955 : m_u(b.first,c) = m_uc[2][b.second][c];
1336 : : }
1337 [ + + ]: 28322865 : for (std::size_t c=0; c<m_p.nprop(); ++c) {
1338 : 19608225 : m_p(b.first,c) = m_pc[2][b.second][c];
1339 : : }
1340 : : }
1341 : :
1342 : 65205 : auto mindt = std::numeric_limits< tk::real >::max();
1343 : :
1344 [ + + ]: 65205 : if (m_stage == 0)
1345 : : {
1346 [ + + ]: 21735 : auto const_dt = g_inputdeck.get< tag::dt >();
1347 : : auto eps = std::numeric_limits< tk::real >::epsilon();
1348 : :
1349 : : // use constant dt if configured
1350 [ + + ]: 21735 : if (std::abs(const_dt) > eps) {
1351 : :
1352 : 19405 : mindt = const_dt;
1353 : :
1354 : : } else { // compute dt based on CFL
1355 : :
1356 : : // find the minimum dt across all PDEs integrated
1357 : : auto eqdt =
1358 : 4660 : g_dgpde[d->MeshId()].dt( myGhosts()->m_coord, myGhosts()->m_inpoel,
1359 : 2330 : myGhosts()->m_fd,
1360 : 2330 : myGhosts()->m_geoFace, myGhosts()->m_geoElem, m_ndof, m_u, m_p,
1361 : 2330 : myGhosts()->m_fd.Esuel().size()/4 );
1362 [ + - ]: 2330 : if (eqdt < mindt) mindt = eqdt;
1363 : :
1364 : 2330 : mindt *= g_inputdeck.get< tag::cfl >();
1365 : : }
1366 : : }
1367 : : else
1368 : : {
1369 : 43470 : mindt = d->Dt();
1370 : : }
1371 : :
1372 : : // Resize the buffer vector of nodal extrema
1373 : 65205 : resizeNodalExtremac();
1374 : :
1375 : : // Contribute to minimum dt across all chares then advance to next step
1376 [ + - ]: 65205 : contribute( sizeof(tk::real), &mindt, CkReduction::min_double,
1377 : 65205 : CkCallback(CkReductionTarget(DG,solve), thisProxy) );
1378 : 65205 : }
1379 : :
1380 : : void
1381 : 65205 : DG::solve( tk::real newdt )
1382 : : // *****************************************************************************
1383 : : // Compute right-hand side of discrete transport equations
1384 : : //! \param[in] newdt Size of this new time step
1385 : : // *****************************************************************************
1386 : : {
1387 : : // Enable SDAG wait for building the solution vector during the next stage
1388 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4sol();
1389 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4refine();
1390 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4smooth();
1391 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4reco();
1392 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4nodalExtrema();
1393 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4lim();
1394 [ + - ]: 65205 : thisProxy[ thisIndex ].wait4nod();
1395 : :
1396 : 65205 : auto d = Disc();
1397 : 65205 : const auto rdof = g_inputdeck.get< tag::rdof >();
1398 : 65205 : const auto ndof = g_inputdeck.get< tag::ndof >();
1399 : 65205 : const auto neq = m_u.nprop()/rdof;
1400 : 65205 : const auto pref = g_inputdeck.get< tag::pref, tag::pref >();
1401 : :
1402 : : // Set new time step size
1403 [ + + ]: 65205 : if (m_stage == 0) d->setdt( newdt );
1404 : :
1405 : : // Update Un
1406 [ + + ]: 65205 : if (m_stage == 0) m_un = m_u;
1407 : :
1408 : : // Explicit or IMEX
1409 : 65205 : const auto imex_runge_kutta = g_inputdeck.get< tag::imex_runge_kutta >();
1410 : :
1411 : : // physical time at time-stage for computing exact source terms
1412 : 65205 : tk::real physT(d->T());
1413 [ + + ]: 65205 : if (m_stage == 1) {
1414 : 21735 : physT += d->Dt();
1415 : : }
1416 [ + + ]: 43470 : else if (m_stage == 2) {
1417 : 21735 : physT += 0.5*d->Dt();
1418 : : }
1419 : :
1420 [ - + ]: 65205 : if (imex_runge_kutta) {
1421 [ - - ]: 0 : if (m_stage == 0)
1422 : : {
1423 : : // Save previous rhs
1424 : : m_rhsprev = m_rhs;
1425 : : // Initialize m_stiffrhs to zero
1426 : : m_stiffrhs.fill(0.0);
1427 : : m_stiffrhsprev.fill(0.0);
1428 : : }
1429 : : }
1430 : :
1431 : 130410 : g_dgpde[d->MeshId()].rhs( physT, pref, myGhosts()->m_geoFace,
1432 : 65205 : myGhosts()->m_geoElem, myGhosts()->m_fd, myGhosts()->m_inpoel, m_boxelems,
1433 : 65205 : myGhosts()->m_coord, m_u, m_p, m_ndof, d->Dt(), m_rhs );
1434 : :
1435 [ + - ]: 65205 : if (!imex_runge_kutta) {
1436 : : // Explicit time-stepping using RK3 to discretize time-derivative
1437 [ + + ]: 25123965 : for(std::size_t e=0; e<myGhosts()->m_nunk; ++e)
1438 [ + + ]: 107161680 : for(std::size_t c=0; c<neq; ++c)
1439 : : {
1440 [ + + ]: 367773870 : for (std::size_t k=0; k<m_numEqDof[c]; ++k)
1441 : : {
1442 [ + + ]: 285670950 : if(k < m_ndof[e]) {
1443 : 200918490 : auto rmark = c*rdof+k;
1444 : 200918490 : auto mark = c*ndof+k;
1445 [ + + ]: 200918490 : m_u(e, rmark) = rkcoef[0][m_stage] * m_un(e, rmark)
1446 : 200918490 : + rkcoef[1][m_stage] * ( m_u(e, rmark)
1447 : 200918490 : + d->Dt() * m_rhs(e, mark)/m_lhs(e, mark) );
1448 [ + + ]: 200918490 : if(fabs(m_u(e, rmark)) < 1e-16)
1449 : 49142850 : m_u(e, rmark) = 0;
1450 : : }
1451 : : }
1452 : : }
1453 : : }
1454 : : else {
1455 : : // Implicit-Explicit time-stepping using RK3 to discretize time-derivative
1456 : 0 : DG::imex_integrate();
1457 : : }
1458 : :
1459 [ + + ]: 25123965 : for(std::size_t e=0; e<myGhosts()->m_nunk; ++e)
1460 [ + + ]: 107161680 : for(std::size_t c=0; c<neq; ++c)
1461 : : {
1462 : : // zero out unused/reconstructed dofs of equations using reduced dofs
1463 : : // (see DGMultiMat::numEquationDofs())
1464 [ + + ]: 82102920 : if (m_numEqDof[c] < rdof) {
1465 [ + + ]: 46420140 : for (std::size_t k=m_numEqDof[c]; k<rdof; ++k)
1466 : : {
1467 : 34815105 : auto rmark = c*rdof+k;
1468 : 34815105 : m_u(e, rmark) = 0.0;
1469 : : }
1470 : : }
1471 : : }
1472 : :
1473 : : // Update primitives based on the evolved solution
1474 : 65205 : g_dgpde[d->MeshId()].updateInterfaceCells( m_u,
1475 : 65205 : myGhosts()->m_fd.Esuel().size()/4, m_ndof, m_interface );
1476 : 65205 : g_dgpde[d->MeshId()].updatePrimitives( m_u, m_lhs, myGhosts()->m_geoElem, m_p,
1477 : 65205 : myGhosts()->m_fd.Esuel().size()/4, m_ndof );
1478 [ + - ]: 65205 : if (!g_inputdeck.get< tag::accuracy_test >()) {
1479 : 65205 : g_dgpde[d->MeshId()].cleanTraceMaterial( physT, myGhosts()->m_geoElem, m_u,
1480 : 65205 : m_p, myGhosts()->m_fd.Esuel().size()/4 );
1481 : : }
1482 : :
1483 [ + + ]: 65205 : if (m_stage < 2) {
1484 : :
1485 : : // continue with next time step stage
1486 : 43470 : stage();
1487 : :
1488 : : } else {
1489 : :
1490 : : // Increase number of iterations and physical time
1491 : 21735 : d->next();
1492 : :
1493 : : // Compute diagnostics, e.g., residuals
1494 : 21735 : auto diag_computed = m_diag.compute( *d,
1495 : 21735 : m_u.nunk()-myGhosts()->m_fd.Esuel().size()/4, myGhosts()->m_geoElem,
1496 : 21735 : m_ndof, m_u, m_un );
1497 : :
1498 : : // Continue to mesh refinement (if configured)
1499 [ + + ][ + - ]: 31663 : if (!diag_computed) refine( std::vector< tk::real >( m_u.nprop(), 0.0 ) );
[ + - ]
1500 : :
1501 : : }
1502 : 65205 : }
1503 : :
1504 : : void
1505 : 21735 : DG::refine( [[maybe_unused]] const std::vector< tk::real >& l2res )
1506 : : // *****************************************************************************
1507 : : // Optionally refine/derefine mesh
1508 : : //! \param[in] l2res L2-norms of the residual for each scalar component
1509 : : //! computed across the whole problem
1510 : : // *****************************************************************************
1511 : : {
1512 : 21735 : auto d = Disc();
1513 : :
1514 : 21735 : auto dtref = g_inputdeck.get< tag::amr, tag::dtref >();
1515 : 21735 : auto dtfreq = g_inputdeck.get< tag::amr, tag::dtfreq >();
1516 : :
1517 : : // if t>0 refinement enabled and we hit the dtref frequency
1518 [ - + ][ - - ]: 21735 : if (dtref && !(d->It() % dtfreq)) { // refine
1519 : :
1520 : 0 : d->startvol();
1521 [ - - ][ - - ]: 0 : d->Ref()->dtref( myGhosts()->m_fd.Bface(), {},
[ - - ][ - - ]
1522 : 0 : tk::remap(myGhosts()->m_fd.Triinpoel(),d->Gid()) );
1523 : 0 : d->refined() = 1;
1524 : :
1525 : : } else { // do not refine
1526 : :
1527 : 21735 : d->refined() = 0;
1528 : 21735 : stage();
1529 : :
1530 : : }
1531 : 21735 : }
1532 : :
1533 : : void
1534 : 0 : DG::resizePostAMR(
1535 : : const std::vector< std::size_t >& /*ginpoel*/,
1536 : : const tk::UnsMesh::Chunk& chunk,
1537 : : const tk::UnsMesh::Coords& coord,
1538 : : const std::unordered_map< std::size_t, tk::UnsMesh::Edge >& /*addedNodes*/,
1539 : : const std::unordered_map< std::size_t, std::size_t >& addedTets,
1540 : : const std::set< std::size_t >& removedNodes,
1541 : : const std::unordered_map< std::size_t, std::size_t >& amrNodeMap,
1542 : : const tk::NodeCommMap& nodeCommMap,
1543 : : const std::map< int, std::vector< std::size_t > >& bface,
1544 : : const std::map< int, std::vector< std::size_t > >& /* bnode */,
1545 : : const std::vector< std::size_t >& triinpoel,
1546 : : const std::unordered_map< std::size_t, std::set< std::size_t > >& elemblockid )
1547 : : // *****************************************************************************
1548 : : // Receive new mesh from Refiner
1549 : : //! \param[in] chunk New mesh chunk (connectivity and global<->local id maps)
1550 : : //! \param[in] coord New mesh node coordinates
1551 : : //! \param[in] addedTets Newly added mesh cells and their parents (local ids)
1552 : : //! \param[in] removedNodes Newly removed mesh node local ids
1553 : : //! \param[in] amrNodeMap Node id map after amr (local ids)
1554 : : //! \param[in] nodeCommMap New node communication map
1555 : : //! \param[in] bface Boundary-faces mapped to side set ids
1556 : : //! \param[in] triinpoel Boundary-face connectivity
1557 : : //! \param[in] elemblockid Local tet ids associated with mesh block ids
1558 : : // *****************************************************************************
1559 : : {
1560 : 0 : auto d = Disc();
1561 : :
1562 : : // Set flag that indicates that we are during time stepping
1563 : 0 : m_initial = 0;
1564 : 0 : myGhosts()->m_initial = 0;
1565 : :
1566 : : // Zero field output iteration count between two mesh refinement steps
1567 : 0 : d->Itf() = 0;
1568 : :
1569 : : // Increase number of iterations with mesh refinement
1570 : 0 : ++d->Itr();
1571 : :
1572 : : // Save old number of elements
1573 : 0 : [[maybe_unused]] auto old_nelem = myGhosts()->m_inpoel.size()/4;
1574 : :
1575 : : // Resize mesh data structures
1576 : 0 : d->resizePostAMR( chunk, coord, amrNodeMap, nodeCommMap, removedNodes,
1577 : : elemblockid );
1578 : :
1579 : : // Update state
1580 : 0 : myGhosts()->m_inpoel = d->Inpoel();
1581 : 0 : myGhosts()->m_coord = d->Coord();
1582 : 0 : auto nelem = myGhosts()->m_inpoel.size()/4;
1583 : : m_p.resize( nelem );
1584 : : m_u.resize( nelem );
1585 : : m_un.resize( nelem );
1586 : : m_lhs.resize( nelem );
1587 : : m_rhs.resize( nelem );
1588 : : m_rhsprev.resize( nelem );
1589 : : m_stiffrhs.resize( nelem );
1590 : : m_stiffrhsprev.resize( nelem );
1591 [ - - ][ - - ]: 0 : m_uNodalExtrm.resize( Disc()->Bid().size(), std::vector<tk::real>( 2*
1592 [ - - ]: 0 : m_ndof_NodalExtrm*g_inputdeck.get< tag::ncomp >() ) );
1593 [ - - ][ - - ]: 0 : m_pNodalExtrm.resize( Disc()->Bid().size(), std::vector<tk::real>( 2*
1594 [ - - ]: 0 : m_ndof_NodalExtrm*m_p.nprop()/g_inputdeck.get< tag::rdof >()));
1595 : :
1596 : : // Resize the buffer vector of nodal extrema
1597 : 0 : resizeNodalExtremac();
1598 : :
1599 [ - - ][ - - ]: 0 : myGhosts()->m_fd = FaceData( myGhosts()->m_inpoel, bface,
[ - - ][ - - ]
[ - - ]
1600 : 0 : tk::remap(triinpoel,d->Lid()) );
1601 : :
1602 [ - - ]: 0 : myGhosts()->m_geoFace =
1603 : 0 : tk::Fields( tk::genGeoFaceTri( myGhosts()->m_fd.Nipfac(),
1604 : 0 : myGhosts()->m_fd.Inpofa(), coord ) );
1605 [ - - ]: 0 : myGhosts()->m_geoElem = tk::Fields( tk::genGeoElemTet( myGhosts()->m_inpoel,
1606 : 0 : coord ) );
1607 : :
1608 : 0 : myGhosts()->m_nfac = myGhosts()->m_fd.Inpofa().size()/3;
1609 : 0 : myGhosts()->m_nunk = nelem;
1610 : 0 : m_npoin = coord[0].size();
1611 : 0 : myGhosts()->m_bndFace.clear();
1612 : 0 : myGhosts()->m_exptGhost.clear();
1613 : 0 : myGhosts()->m_sendGhost.clear();
1614 : 0 : myGhosts()->m_ghost.clear();
1615 : 0 : myGhosts()->m_esup.clear();
1616 : :
1617 : : // Update solution on new mesh, P0 (cell center value) only for now
1618 : : m_un = m_u;
1619 : : auto pn = m_p;
1620 : 0 : auto unprop = m_u.nprop();
1621 : : auto pnprop = m_p.nprop();
1622 [ - - ]: 0 : for (const auto& [child,parent] : addedTets) {
1623 : : Assert( child < nelem, "Indexing out of new solution vector" );
1624 : : Assert( parent < old_nelem, "Indexing out of old solution vector" );
1625 [ - - ]: 0 : for (std::size_t i=0; i<unprop; ++i) m_u(child,i) = m_un(parent,i);
1626 [ - - ]: 0 : for (std::size_t i=0; i<pnprop; ++i) m_p(child,i) = pn(parent,i);
1627 : : }
1628 : : m_un = m_u;
1629 : :
1630 : : // Resize communication buffers
1631 [ - - ][ - - ]: 0 : m_ghosts[thisIndex].resizeComm();
[ - - ][ - - ]
1632 : 0 : }
1633 : :
1634 : : bool
1635 : 19324 : DG::fieldOutput() const
1636 : : // *****************************************************************************
1637 : : // Decide wether to output field data
1638 : : //! \return True if field data is output in this step
1639 : : // *****************************************************************************
1640 : : {
1641 : 19324 : auto d = Disc();
1642 : :
1643 : : // Output field data
1644 [ + + ][ + - ]: 19324 : return d->fielditer() or d->fieldtime() or d->fieldrange() or d->finished();
[ + - ][ + + ]
1645 : : }
1646 : :
1647 : : bool
1648 : 2022 : DG::refinedOutput() const
1649 : : // *****************************************************************************
1650 : : // Decide if we write field output using a refined mesh
1651 : : //! \return True if field output will use a refined mesh
1652 : : // *****************************************************************************
1653 : : {
1654 [ + + ]: 2022 : return g_inputdeck.get< tag::field_output, tag::refined >() &&
1655 [ - + ]: 33 : g_inputdeck.get< tag::scheme >() != ctr::SchemeType::DG;
1656 : : }
1657 : :
1658 : : void
1659 : 2022 : DG::writeFields(
1660 : : CkCallback c,
1661 : : const std::unordered_map< std::size_t, std::size_t >& addedTets )
1662 : : // *****************************************************************************
1663 : : // Output mesh field data
1664 : : //! \param[in] c Function to continue with after the write
1665 : : //! \param[in] addedTets Newly added mesh cells and their parents (local ids)
1666 : : // *****************************************************************************
1667 : : {
1668 : 2022 : auto d = Disc();
1669 : :
1670 : : const auto& inpoel = std::get< 0 >( m_outmesh.chunk );
1671 : 4044 : auto esup = tk::genEsup( inpoel, 4 );
1672 : 2022 : auto nelem = inpoel.size() / 4;
1673 : :
1674 : : // Combine own and communicated contributions and finish averaging of node
1675 : : // field output in chare boundary nodes
1676 : : const auto& lid = std::get< 2 >( m_outmesh.chunk );
1677 [ + + ]: 81925 : for (const auto& [g,f] : m_uNodefieldsc) {
1678 : : Assert( m_uNodefields.nprop() == f.first.size(), "Size mismatch" );
1679 : 79903 : auto p = tk::cref_find( lid, g );
1680 [ + + ]: 325032 : for (std::size_t i=0; i<f.first.size(); ++i) {
1681 : 245129 : m_uNodefields(p,i) += f.first[i];
1682 : 245129 : m_uNodefields(p,i) /= static_cast< tk::real >(
1683 : 245129 : esup.second[p+1] - esup.second[p] + f.second );
1684 : : }
1685 : : }
1686 : 2022 : tk::destroy( m_uNodefieldsc );
1687 [ + + ]: 81925 : for (const auto& [g,f] : m_pNodefieldsc) {
1688 : : Assert( m_pNodefields.nprop() == f.first.size(), "Size mismatch" );
1689 : 79903 : auto p = tk::cref_find( lid, g );
1690 [ + + ]: 110631 : for (std::size_t i=0; i<f.first.size(); ++i) {
1691 : 30728 : m_pNodefields(p,i) += f.first[i];
1692 : 30728 : m_pNodefields(p,i) /= static_cast< tk::real >(
1693 : 30728 : esup.second[p+1] - esup.second[p] + f.second );
1694 : : }
1695 : : }
1696 : 2022 : tk::destroy( m_pNodefieldsc );
1697 : :
1698 : : // Lambda to decide if a node (global id) is on a chare boundary of the field
1699 : : // output mesh. p - global node id, return true if node is on the chare
1700 : : // boundary.
1701 : : auto chbnd = [ this ]( std::size_t p ) {
1702 : : return
1703 : : std::any_of( m_outmesh.nodeCommMap.cbegin(), m_outmesh.nodeCommMap.cend(),
1704 : : [&](const auto& s) { return s.second.find(p) != s.second.cend(); } );
1705 : : };
1706 : :
1707 : : // Finish computing node field output averages in internal nodes
1708 : 2022 : auto npoin = m_outmesh.coord[0].size();
1709 : : auto& gid = std::get< 1 >( m_outmesh.chunk );
1710 [ + + ]: 397996 : for (std::size_t p=0; p<npoin; ++p) {
1711 [ + + ]: 395974 : if (!chbnd(gid[p])) {
1712 : 316071 : auto n = static_cast< tk::real >( esup.second[p+1] - esup.second[p] );
1713 [ + + ]: 1244889 : for (std::size_t i=0; i<m_uNodefields.nprop(); ++i)
1714 : 928818 : m_uNodefields(p,i) /= n;
1715 [ + + ]: 416729 : for (std::size_t i=0; i<m_pNodefields.nprop(); ++i)
1716 : 100658 : m_pNodefields(p,i) /= n;
1717 : : }
1718 : : }
1719 : :
1720 : : // Collect field output from numerical solution requested by user
1721 : 2022 : auto elemfields = numericFieldOutput( m_uElemfields, tk::Centering::ELEM,
1722 [ + - ][ + - ]: 4044 : g_dgpde[Disc()->MeshId()].OutVarFn(), m_pElemfields );
[ + - ]
1723 : 2022 : auto nodefields = numericFieldOutput( m_uNodefields, tk::Centering::NODE,
1724 [ + - ][ + - ]: 4044 : g_dgpde[Disc()->MeshId()].OutVarFn(), m_pNodefields );
[ + - ]
1725 : :
1726 : : // Collect field output from analytical solutions (if exist)
1727 : 2022 : const auto& coord = m_outmesh.coord;
1728 [ + - ]: 2022 : auto geoElem = tk::genGeoElemTet( inpoel, coord );
1729 [ + - ]: 2022 : auto t = Disc()->T();
1730 [ + - ]: 2022 : analyticFieldOutput( g_dgpde[d->MeshId()], tk::Centering::ELEM,
1731 [ + - ][ + - ]: 8088 : geoElem.extract_comp(1), geoElem.extract_comp(2), geoElem.extract_comp(3),
[ + - ][ + - ]
[ + - ][ + - ]
[ - - ][ - - ]
1732 : : t, elemfields );
1733 [ + - ]: 2022 : analyticFieldOutput( g_dgpde[d->MeshId()], tk::Centering::NODE, coord[0],
1734 : : coord[1], coord[2], t, nodefields );
1735 : :
1736 : : // Add adaptive indicator array to element-centered field output
1737 [ + + ]: 2022 : if (g_inputdeck.get< tag::pref, tag::pref >()) {
1738 [ + - ]: 402 : std::vector< tk::real > ndof( begin(m_ndof), end(m_ndof) );
1739 [ + - ]: 402 : ndof.resize( nelem );
1740 [ + + ]: 182529 : for(std::size_t k = 0; k < nelem; k++) {
1741 : : // Mark the cell with THINC reconstruction as 0 for output
1742 [ + + ]: 182127 : if(m_interface[k] == 1) ndof[k] = 0;
1743 : : }
1744 [ + + ]: 87834 : for (const auto& [child,parent] : addedTets)
1745 : 87432 : ndof[child] = static_cast< tk::real >( m_ndof[parent] );
1746 [ + - ]: 402 : elemfields.push_back( ndof );
1747 : : }
1748 : :
1749 : : // Add shock detection marker array to element-centered field output
1750 [ + - ][ - - ]: 2022 : std::vector< tk::real > shockmarker( begin(m_shockmarker), end(m_shockmarker) );
1751 : : // Here m_shockmarker has a size of m_u.nunk() which is the number of the
1752 : : // elements within this partition (nelem) plus the ghost partition cells. In
1753 : : // terms of output purpose, we only need the solution data within this
1754 : : // partition. Therefore, resizing it to nelem removes the extra partition
1755 : : // boundary allocations in the shockmarker vector. Since the code assumes that
1756 : : // the boundary elements are on the top, the resize operation keeps the lower
1757 : : // portion.
1758 [ + - ]: 2022 : shockmarker.resize( nelem );
1759 [ + + ]: 159534 : for (const auto& [child,parent] : addedTets)
1760 : 157512 : shockmarker[child] = static_cast< tk::real >(m_shockmarker[parent]);
1761 [ + - ]: 2022 : elemfields.push_back( shockmarker );
1762 : :
1763 : : // Add rho0*det(g)/rho to make sure it is staying close to 1,
1764 : : // averaged for all materials
1765 [ + - ][ - - ]: 2022 : std::vector< tk::real > densityConstr(nelem);
1766 [ + - ]: 2022 : g_dgpde[d->MeshId()].computeDensityConstr(nelem, m_u, densityConstr);
1767 [ + + ]: 159534 : for (const auto& [child,parent] : addedTets)
1768 : 157512 : densityConstr[child] = 0.0;
1769 [ + + ][ + - ]: 2022 : if (densityConstr.size() > 0) elemfields.push_back( densityConstr );
1770 : :
1771 : : // Query fields names requested by user
1772 [ + - ]: 4044 : auto elemfieldnames = numericFieldNames( tk::Centering::ELEM );
1773 [ + - ]: 2022 : auto nodefieldnames = numericFieldNames( tk::Centering::NODE );
1774 : :
1775 : : // Collect field output names for analytical solutions
1776 [ + - ]: 2022 : analyticFieldNames( g_dgpde[d->MeshId()], tk::Centering::ELEM, elemfieldnames );
1777 [ + - ]: 2022 : analyticFieldNames( g_dgpde[d->MeshId()], tk::Centering::NODE, nodefieldnames );
1778 : :
1779 [ + + ]: 2022 : if (g_inputdeck.get< tag::pref, tag::pref >()) {
1780 [ + - ]: 804 : elemfieldnames.push_back( "NDOF" );
1781 : : }
1782 : :
1783 [ + - ]: 2022 : elemfieldnames.push_back( "shock_marker" );
1784 : :
1785 [ + + ]: 2022 : if (densityConstr.size() > 0)
1786 [ + - ]: 310 : elemfieldnames.push_back( "density_constraint" );
1787 : :
1788 : : Assert( elemfieldnames.size() == elemfields.size(), "Size mismatch" );
1789 : : Assert( nodefieldnames.size() == nodefields.size(), "Size mismatch" );
1790 : :
1791 : : // Output chare mesh and fields metadata to file
1792 : 2022 : const auto& triinpoel = m_outmesh.triinpoel;
1793 [ + - ][ + - ]: 6066 : d->write( inpoel, m_outmesh.coord, m_outmesh.bface, {},
[ + + ][ - - ]
1794 [ + - ]: 4044 : tk::remap( triinpoel, lid ), elemfieldnames, nodefieldnames,
1795 : : {}, {}, elemfields, nodefields, {}, {}, c );
1796 : 2022 : }
1797 : :
1798 : : void
1799 : 12610 : DG::comnodeout( const std::vector< std::size_t >& gid,
1800 : : const std::vector< std::size_t >& nesup,
1801 : : const std::vector< std::vector< tk::real > >& Lu,
1802 : : const std::vector< std::vector< tk::real > >& Lp )
1803 : : // *****************************************************************************
1804 : : // Receive chare-boundary nodal solution (for field output) contributions from
1805 : : // neighboring chares
1806 : : //! \param[in] gid Global mesh node IDs at which we receive contributions
1807 : : //! \param[in] nesup Number of elements surrounding points
1808 : : //! \param[in] Lu Partial contributions of solution nodal fields to
1809 : : //! chare-boundary nodes
1810 : : //! \param[in] Lp Partial contributions of primitive quantity nodal fields to
1811 : : //! chare-boundary nodes
1812 : : // *****************************************************************************
1813 : : {
1814 : : Assert( gid.size() == nesup.size(), "Size mismatch" );
1815 : : Assert(Lu.size() == m_uNodefields.nprop(), "Fields size mismatch");
1816 : : Assert(Lp.size() == m_pNodefields.nprop(), "Fields size mismatch");
1817 [ + + ]: 60672 : for (std::size_t f=0; f<Lu.size(); ++f)
1818 : : Assert( gid.size() == Lu[f].size(), "Size mismatch" );
1819 [ + + ]: 20126 : for (std::size_t f=0; f<Lp.size(); ++f)
1820 : : Assert( gid.size() == Lp[f].size(), "Size mismatch" );
1821 : :
1822 [ + + ]: 133974 : for (std::size_t i=0; i<gid.size(); ++i) {
1823 : : auto& nfu = m_uNodefieldsc[ gid[i] ];
1824 : 121364 : nfu.first.resize( Lu.size() );
1825 [ + + ]: 561362 : for (std::size_t f=0; f<Lu.size(); ++f) nfu.first[f] += Lu[f][i];
1826 : 121364 : nfu.second += nesup[i];
1827 : 121364 : auto& nfp = m_pNodefieldsc[ gid[i] ];
1828 : 121364 : nfp.first.resize( Lp.size() );
1829 [ + + ]: 193940 : for (std::size_t f=0; f<Lp.size(); ++f) nfp.first[f] += Lp[f][i];
1830 : 121364 : nfp.second += nesup[i];
1831 : : }
1832 : :
1833 : : // When we have heard from all chares we communicate with, this chare is done
1834 [ + + ]: 12610 : if (++m_nnod == Disc()->NodeCommMap().size()) {
1835 : 1852 : m_nnod = 0;
1836 : 1852 : comnodeout_complete();
1837 : : }
1838 : 12610 : }
1839 : :
1840 : : void
1841 : 65205 : DG::stage()
1842 : : // *****************************************************************************
1843 : : // Evaluate whether to continue with next time step stage
1844 : : // *****************************************************************************
1845 : : {
1846 : : // Increment Runge-Kutta stage counter
1847 : 65205 : ++m_stage;
1848 : :
1849 : : // if not all Runge-Kutta stages complete, continue to next time stage,
1850 : : // otherwise prepare for nodal field output
1851 [ + + ]: 65205 : if (m_stage < 3)
1852 : 43470 : next();
1853 : : else
1854 [ + - ][ + - ]: 65205 : startFieldOutput( CkCallback(CkIndex_DG::step(), thisProxy[thisIndex]) );
[ - + ][ - - ]
1855 : 65205 : }
1856 : :
1857 : : void
1858 : 20934 : DG::evalLB( int nrestart )
1859 : : // *****************************************************************************
1860 : : // Evaluate whether to do load balancing
1861 : : //! \param[in] nrestart Number of times restarted
1862 : : // *****************************************************************************
1863 : : {
1864 : 20934 : auto d = Disc();
1865 : :
1866 : : // Detect if just returned from a checkpoint and if so, zero timers
1867 : 20934 : d->restarted( nrestart );
1868 : :
1869 : 20934 : const auto lbfreq = g_inputdeck.get< tag::cmd, tag::lbfreq >();
1870 : 20934 : const auto nonblocking = g_inputdeck.get< tag::cmd, tag::nonblocking >();
1871 : :
1872 : : // Load balancing if user frequency is reached or after the second time-step
1873 [ + + ][ + + ]: 20934 : if ( (d->It()) % lbfreq == 0 || d->It() == 2 ) {
1874 : :
1875 : 17814 : AtSync();
1876 [ - + ]: 17814 : if (nonblocking) next();
1877 : :
1878 : : } else {
1879 : :
1880 : 3120 : next();
1881 : :
1882 : : }
1883 : 20934 : }
1884 : :
1885 : : void
1886 : 20934 : DG::evalRestart()
1887 : : // *****************************************************************************
1888 : : // Evaluate whether to save checkpoint/restart
1889 : : // *****************************************************************************
1890 : : {
1891 : 20934 : auto d = Disc();
1892 : :
1893 : 20934 : const auto rsfreq = g_inputdeck.get< tag::cmd, tag::rsfreq >();
1894 : 20934 : const auto benchmark = g_inputdeck.get< tag::cmd, tag::benchmark >();
1895 : :
1896 [ + + ][ - + ]: 20934 : if (not benchmark and not (d->It() % rsfreq)) {
1897 : :
1898 : 0 : std::vector< std::size_t > meshdata{ /* finished = */ 0, d->MeshId() };
1899 [ - - ]: 0 : contribute( meshdata, CkReduction::nop,
1900 [ - - ][ - - ]: 0 : CkCallback(CkReductionTarget(Transporter,checkpoint), d->Tr()) );
[ - - ]
1901 : :
1902 : : } else {
1903 : :
1904 : 20934 : evalLB( /* nrestart = */ -1 );
1905 : :
1906 : : }
1907 : 20934 : }
1908 : :
1909 : : void
1910 : 21735 : DG::step()
1911 : : // *****************************************************************************
1912 : : // Evaluate wether to continue with next time step
1913 : : // *****************************************************************************
1914 : : {
1915 : 21735 : auto d = Disc();
1916 : :
1917 : : // Output time history
1918 [ + - ][ + - ]: 21735 : if (d->histiter() or d->histtime() or d->histrange()) {
[ - + ]
1919 : 0 : std::vector< std::vector< tk::real > > hist;
1920 [ - - ][ - - ]: 0 : auto h = g_dgpde[d->MeshId()].histOutput( d->Hist(), myGhosts()->m_inpoel,
1921 [ - - ][ - - ]: 0 : myGhosts()->m_coord, m_u, m_p );
1922 [ - - ]: 0 : hist.insert( end(hist), begin(h), end(h) );
1923 [ - - ]: 0 : d->history( std::move(hist) );
1924 : : }
1925 : :
1926 : : // Free memory storing output mesh
1927 : 21735 : m_outmesh.destroy();
1928 : :
1929 : : // Output one-liner status report to screen
1930 : 21735 : d->status();
1931 : : // Reset Runge-Kutta stage counter
1932 : 21735 : m_stage = 0;
1933 : :
1934 : 21735 : const auto term = g_inputdeck.get< tag::term >();
1935 : 21735 : const auto nstep = g_inputdeck.get< tag::nstep >();
1936 : : const auto eps = std::numeric_limits< tk::real >::epsilon();
1937 : :
1938 : : // If neither max iterations nor max time reached, continue, otherwise finish
1939 [ + - ][ + + ]: 21735 : if (std::fabs(d->T()-term) > eps && d->It() < nstep) {
1940 : :
1941 : 20934 : evalRestart();
1942 : :
1943 : : } else {
1944 : :
1945 : 801 : auto meshid = d->MeshId();
1946 [ + - ]: 1602 : d->contribute( sizeof(std::size_t), &meshid, CkReduction::nop,
1947 : 1602 : CkCallback(CkReductionTarget(Transporter,finish), d->Tr()) );
1948 : :
1949 : : }
1950 : 21735 : }
1951 : :
1952 : : void
1953 : 0 : DG::imex_integrate()
1954 : : {
1955 : : /*****************************************************************************
1956 : : Performs the Implicit-Explicit Runge-Kutta step.
1957 : :
1958 : : \details Performs the Implicit-Explicit Runge-Kutta step. Scheme taken from
1959 : : Cavaglieri, D., & Bewley, T. (2015). Low-storage implicit/explicit Runge–Kutta
1960 : : schemes for the simulation of stiff high-dimensional ODE systems. Journal of
1961 : : Computational Physics, 286, 172-193.
1962 : :
1963 : : Scheme given by equations (25a,b):
1964 : :
1965 : : u[0] = u[n] + dt * (expl_rkcoef[1,0]*R_ex(u[n])+impl_rkcoef[1,1]*R_im(u[0]))
1966 : :
1967 : : u[1] = u[n] + dt * (expl_rkcoef[2,1]*R_ex(u[0])+impl_rkcoef[2,1]*R_im(u[0])
1968 : : +impl_rkcoef[2,2]*R_im(u[1]))
1969 : :
1970 : : u[n+1] = u[n] + dt * (expl_rkcoef[3,1]*R_ex(u[0])+impl_rkcoef[3,1]*R_im(u[0])
1971 : : expl_rkcoef[3,2]*R_ex(u[1])+impl_rkcoef[3,2]*R_im(u[1]))
1972 : :
1973 : : In order to solve the first two equations we need to solve a series of systems
1974 : : of non-linear equations:
1975 : :
1976 : : F1(u[0]) = B1 + R1(u[0]) = 0, and
1977 : : F2(u[1]) = B2 + R2(u[1]) = 0,
1978 : :
1979 : : where
1980 : :
1981 : : B1 = u[n] + dt * expl_rkcoef[1,0]*R_ex(u[n]),
1982 : : R1 = dt * impl_rkcoef[1,1]*R_im(u[0]) - u([0]),
1983 : : B2 = u[n] + dt * (expl_rkcoef[2,1]*R_ex(u[0])+impl_rkcoef[2,1]*R_im(u[0])),
1984 : : R2 = dt * impl_rkcoef[2,2]*R_im(u[1]) - u([1]).
1985 : :
1986 : : In order to solve the non-linear system F(U) = 0, we employ Broyden's method.
1987 : : Taken from https://en.wikipedia.org/wiki/Broyden%27s_method.
1988 : : The method consists in obtaining an approximation for the inverse of the
1989 : : Jacobian H = J^(-1) and advancing in a quasi-newton step:
1990 : :
1991 : : U[k+1] = U[k] - H[k]*F(U[k]),
1992 : :
1993 : : until F(U) is close enough to zero.
1994 : :
1995 : : The approximation H[k] is improved at every iteration following
1996 : :
1997 : : H[k] = H[k-1] + (DU[k]-H[k-1]*DF[k])/(DU[k]^T*H[k-1]*DF[k]) * DU[k]^T*H[k-1],
1998 : :
1999 : : where DU[k] = U[k] - U[k-1] and DF[k] = F(U[k]) - F(U[k-1)).
2000 : :
2001 : : This function performs the following main algorithmic steps:
2002 : : - If stage == 0 or stage == 1:
2003 : : - Take Initial value:
2004 : : U[0] = U[n] + dt * expl_rkcoef[1,0]*R_ex(U[n]) (for stage 0)
2005 : : U[1] = U[n] + dt * (expl_rkcoef[2,1]*R_ex(U[0])
2006 : : +impl_rkcoef[2,1]*R_im(U[0])) (for stage 1)
2007 : : - Loop over the Elements (e++)
2008 : : - Initialize Jacobian inverse approximation as the identity
2009 : : - Compute implicit right-hand-side (F_im) with current U
2010 : : - Iterate for the solution (iter++)
2011 : : - Compute new solution U[k+1] = U[k] - H[k]*F(U[k])
2012 : : - Compute implicit right-hand-side (F_im) with current U
2013 : : - Compute DU and DF
2014 : : - Update inverse Jacobian approximation by:
2015 : : - Compute V1 = H[k-1]*DF[k] and V2 = DU[k]^T*H[k-1]
2016 : : - Compute d = DU[k]^T*V1 and V3 = DU[k]-V1
2017 : : - Compute V4 = V3/d
2018 : : - Update H[k] = H[k-1] + V4*V2
2019 : : - Save old U and F
2020 : : - Compute absolute and relative errors
2021 : : - Break iterations if error < tol or iter == max_iter
2022 : : - Update explicit equations using only the explicit terms.
2023 : : - Else if stage == 2:
2024 : : - Update explicit equations using only the explicit terms.
2025 : : - Update implicit equations using:
2026 : : u[n+1] = u[n]+dt*(expl_rkcoef[3,1]*R_ex(u[0])+impl_rkcoef[3,1]*R_im(u[0])
2027 : : expl_rkcoef[3,2]*R_ex(u[1])+impl_rkcoef[3,2]*R_im(u[1]))
2028 : :
2029 : : ******************************************************************************/
2030 : 0 : auto d = Disc();
2031 : 0 : const auto rdof = g_inputdeck.get< tag::rdof >();
2032 : 0 : const auto ndof = g_inputdeck.get< tag::ndof >();
2033 [ - - ]: 0 : if (m_stage < 2) {
2034 : : // Save previous stiff_rhs
2035 : : m_stiffrhsprev = m_stiffrhs;
2036 : :
2037 : : // Compute the imex update
2038 : :
2039 : : // Integrate explicitly on the imex equations
2040 : : // (To use as initial values)
2041 [ - - ]: 0 : for (std::size_t e=0; e<myGhosts()->m_nunk; ++e)
2042 [ - - ]: 0 : for (std::size_t c=0; c<m_nstiffeq; ++c)
2043 : : {
2044 [ - - ]: 0 : for (std::size_t k=0; k<m_numEqDof[c]; ++k)
2045 : : {
2046 [ - - ]: 0 : auto rmark = m_stiffEqIdx[c]*rdof+k;
2047 [ - - ]: 0 : auto mark = m_stiffEqIdx[c]*ndof+k;
2048 : 0 : m_u(e, rmark) = m_un(e, rmark) + d->Dt() * (
2049 : 0 : expl_rkcoef[0][m_stage] * m_rhsprev(e, mark)/m_lhs(e, mark)
2050 : 0 : + expl_rkcoef[1][m_stage] * m_rhs(e, mark)/m_lhs(e, mark)
2051 : 0 : + impl_rkcoef[0][m_stage]
2052 : 0 : * m_stiffrhsprev(e,c*ndof+k)/m_lhs(e, mark) );
2053 [ - - ]: 0 : if(fabs(m_u(e, rmark)) < 1e-16)
2054 : 0 : m_u(e, rmark) = 0;
2055 : : }
2056 : : }
2057 : :
2058 : : // Solve for implicit-explicit equations
2059 : 0 : const auto nelem = myGhosts()->m_fd.Esuel().size()/4;
2060 [ - - ]: 0 : for (std::size_t e=0; e<nelem; ++e)
2061 : : {
2062 : : // Non-linear system f(u) = 0 to be solved
2063 : : // Broyden's method
2064 : : // Control parameters
2065 : 0 : std::size_t max_iter = g_inputdeck.get< tag::imex_maxiter >();
2066 : 0 : tk::real rel_tol = g_inputdeck.get< tag::imex_reltol >();
2067 : 0 : tk::real abs_tol = g_inputdeck.get< tag::imex_abstol >();
2068 : : tk::real rel_err = rel_tol+1;
2069 : : tk::real abs_err = abs_tol+1;
2070 : 0 : std::size_t nstiff = m_nstiffeq*ndof;
2071 : :
2072 : : // Initialize Jacobian to be the identity
2073 : : std::vector< std::vector< tk::real > >
2074 [ - - ][ - - ]: 0 : approx_jacob(nstiff, std::vector< tk::real >(nstiff, 0.0));
2075 [ - - ]: 0 : for (std::size_t i=0; i<nstiff; ++i)
2076 : 0 : approx_jacob[i][i] = 1.0e+00;
2077 : :
2078 : : // Save explicit terms to be re-used
2079 [ - - ]: 0 : std::vector< tk::real > expl_terms(nstiff, 0.0);
2080 [ - - ]: 0 : for (size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2081 [ - - ]: 0 : for (size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2082 : : {
2083 : 0 : auto stiffmark = m_stiffEqIdx[ieq]*ndof+idof;
2084 : 0 : auto stiffrmark = m_stiffEqIdx[ieq]*rdof+idof;
2085 : 0 : expl_terms[ieq*ndof+idof] = m_un(e, stiffrmark)
2086 : 0 : + d->Dt() * ( expl_rkcoef[0][m_stage]
2087 : 0 : * m_rhsprev(e,stiffmark)/m_lhs(e,stiffmark)
2088 : 0 : + expl_rkcoef[1][m_stage]
2089 : 0 : * m_rhs(e,stiffmark)/m_lhs(e,stiffmark)
2090 : 0 : + impl_rkcoef[0][m_stage]
2091 : 0 : * m_stiffrhsprev(e,ieq*ndof+idof)/m_lhs(e,stiffmark) );
2092 : : }
2093 : :
2094 : : // Compute stiff_rhs with initial u
2095 [ - - ][ - - ]: 0 : g_dgpde[d->MeshId()].stiff_rhs( e, myGhosts()->m_geoElem,
2096 [ - - ][ - - ]: 0 : myGhosts()->m_inpoel, myGhosts()->m_coord,
2097 [ - - ]: 0 : m_u, m_p, m_ndof, m_stiffrhs );
2098 : :
2099 : : // Make auxiliary u_old and f_old to store previous values
2100 [ - - ][ - - ]: 0 : std::vector< tk::real > u_old(nstiff, 0.0), f_old(nstiff, 0.0);
[ - - ][ - - ]
2101 : : // Make delta_u and delta_f
2102 [ - - ][ - - ]: 0 : std::vector< tk::real > delta_u(nstiff, 0.0), delta_f(nstiff, 0.0);
[ - - ][ - - ]
2103 : : // Store f
2104 [ - - ][ - - ]: 0 : std::vector< tk::real > f(nstiff, 0.0);
2105 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2106 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2107 : : {
2108 : 0 : auto stiffrmark = m_stiffEqIdx[ieq]*rdof+idof;
2109 : 0 : auto stiffmark = m_stiffEqIdx[ieq]*ndof+idof;
2110 : 0 : f[ieq*ndof+idof] = expl_terms[ieq*ndof+idof]
2111 : 0 : + d->Dt() * impl_rkcoef[1][m_stage]
2112 : 0 : * m_stiffrhs(e,ieq*ndof+idof)/m_lhs(e,stiffmark)
2113 : 0 : - m_u(e, stiffrmark);
2114 : : }
2115 : :
2116 : : // Initialize u_old and f_old
2117 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2118 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2119 : : {
2120 : 0 : u_old[ieq*ndof+idof] = m_u(e, m_stiffEqIdx[ieq]*rdof+idof);
2121 : 0 : f_old[ieq*ndof+idof] = f[ieq*ndof+idof];
2122 : : }
2123 : :
2124 : : // Store the norm of f initially, for relative error measure
2125 : : tk::real err0 = 0.0;
2126 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2127 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2128 : 0 : err0 += f[ieq*ndof+idof]*f[ieq*ndof+idof];
2129 : 0 : err0 = std::sqrt(err0);
2130 : :
2131 : : // Iterate for the solution if err0 > 0
2132 [ - - ]: 0 : if (err0 > abs_tol)
2133 [ - - ]: 0 : for (size_t iter=0; iter<max_iter; ++iter)
2134 : : {
2135 : :
2136 : : // Compute new solution
2137 : : tk::real delta;
2138 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2139 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2140 : : {
2141 : : delta = 0.0;
2142 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2143 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2144 : 0 : delta +=
2145 : 0 : approx_jacob[ieq*ndof+idof][jeq*ndof+jdof] * f[jeq*ndof+jdof];
2146 : : // Update u
2147 : 0 : auto stiffrmark = m_stiffEqIdx[ieq]*rdof+idof;
2148 : 0 : m_u(e, stiffrmark) -= delta;
2149 : : }
2150 : :
2151 : : // Compute new stiff_rhs
2152 [ - - ][ - - ]: 0 : g_dgpde[d->MeshId()].stiff_rhs( e, myGhosts()->m_geoElem,
2153 [ - - ][ - - ]: 0 : myGhosts()->m_inpoel, myGhosts()->m_coord,
[ - - ]
2154 : : m_u, m_p, m_ndof, m_stiffrhs );
2155 : :
2156 : : // Compute new f(u)
2157 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2158 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2159 : : {
2160 : 0 : auto stiffrmark = m_stiffEqIdx[ieq]*rdof+idof;
2161 : 0 : auto stiffmark = m_stiffEqIdx[ieq]*ndof+idof;
2162 : 0 : f[ieq*ndof+idof] = expl_terms[ieq*ndof+idof]
2163 : 0 : + d->Dt() * impl_rkcoef[1][m_stage]
2164 : 0 : * m_stiffrhs(e,ieq*ndof+idof)/m_lhs(e,stiffmark)
2165 : 0 : - m_u(e, stiffrmark);
2166 : : }
2167 : :
2168 : : // Compute delta_u and delta_f
2169 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2170 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2171 : : {
2172 : 0 : auto stiffrmark = m_stiffEqIdx[ieq]*rdof+idof;
2173 : 0 : delta_u[ieq*ndof+idof] = m_u(e, stiffrmark) - u_old[ieq*ndof+idof];
2174 : 0 : delta_f[ieq*ndof+idof] = f[ieq*ndof+idof] - f_old[ieq*ndof+idof];
2175 : : }
2176 : :
2177 : : // Update inverse Jacobian approximation
2178 : :
2179 : : // 1. Compute approx_jacob*delta_f and delta_u*jacob_approx
2180 : : tk::real sum1, sum2;
2181 [ - - ][ - - ]: 0 : std::vector< tk::real > auxvec1(nstiff, 0.0), auxvec2(nstiff, 0.0);
[ - - ][ - - ]
2182 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2183 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2184 : : {
2185 : : sum1 = 0.0;
2186 : : sum2 = 0.0;
2187 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2188 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2189 : : {
2190 : 0 : sum1 += approx_jacob[ieq*ndof+idof][jeq*ndof+jdof] *
2191 : 0 : delta_f[jeq*ndof+jdof];
2192 : 0 : sum2 += delta_u[jeq*ndof+jdof] *
2193 : 0 : approx_jacob[jeq*ndof+jdof][ieq*ndof+idof];
2194 : : }
2195 : 0 : auxvec1[ieq*ndof+idof] = sum1;
2196 : 0 : auxvec2[ieq*ndof+idof] = sum2;
2197 : : }
2198 : :
2199 : : // 2. Compute delta_u*approx_jacob*delta_f
2200 : : // and delta_u-approx_jacob*delta_f
2201 : : tk::real denom = 0.0;
2202 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2203 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2204 : : {
2205 : 0 : denom += delta_u[jeq*ndof+jdof]*auxvec1[jeq*ndof+jdof];
2206 : 0 : auxvec1[jeq*ndof+jdof] =
2207 : 0 : delta_u[jeq*ndof+jdof]-auxvec1[jeq*ndof+jdof];
2208 : : }
2209 : :
2210 : : // 3. Divide delta_u+approx_jacob*delta_f
2211 : : // by delta_u*(approx_jacob*delta_f)
2212 [ - - ]: 0 : if (std::abs(denom) < 1.0e-18)
2213 : : {
2214 [ - - ]: 0 : if (denom < 0.0)
2215 : : {
2216 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2217 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2218 : 0 : auxvec1[jeq*ndof+jdof] /= -1.0e-18;
2219 : : }
2220 : : else
2221 : : {
2222 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2223 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2224 : 0 : auxvec1[jeq*ndof+jdof] /= 1.0e-18;
2225 : : }
2226 : : }
2227 : : else
2228 : : {
2229 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2230 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2231 : 0 : auxvec1[jeq*ndof+jdof] /= denom;
2232 : : }
2233 : :
2234 : : // 4. Perform outter product between the two arrays and
2235 : : // add that quantity to the new jacobian approximation
2236 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2237 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2238 [ - - ]: 0 : for (std::size_t jeq=0; jeq<m_nstiffeq; ++jeq)
2239 [ - - ]: 0 : for (std::size_t jdof=0; jdof<m_numEqDof[jeq]; ++jdof)
2240 : 0 : approx_jacob[ieq*ndof+idof][jeq*ndof+jdof] +=
2241 : 0 : auxvec1[ieq*ndof+idof] * auxvec2[jeq*ndof+jdof];
2242 : :
2243 : : // Save solution and f
2244 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2245 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2246 : : {
2247 : 0 : u_old[ieq*ndof+idof] = m_u(e, m_stiffEqIdx[ieq]*rdof+idof);
2248 : 0 : f_old[ieq*ndof+idof] = f[ieq*ndof+idof];
2249 : : }
2250 : :
2251 : : // Compute a measure of error, use norm of f
2252 : : tk::real err = 0.0;
2253 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2254 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2255 : 0 : err += f[ieq*ndof+idof]*f[ieq*ndof+idof];
2256 : 0 : abs_err = std::sqrt(err);
2257 : 0 : rel_err = abs_err/err0;
2258 : :
2259 : : // Check if error condition is met and loop back
2260 [ - - ][ - - ]: 0 : if (rel_err < rel_tol || abs_err < abs_tol)
2261 : : break;
2262 : :
2263 : : // If we did not converge, print a message
2264 [ - - ]: 0 : if (iter == max_iter-1)
2265 : : {
2266 [ - - ]: 0 : printf("\nIMEX-RK: Non-linear solver did not converge in %lu iterations\n", max_iter);
2267 [ - - ]: 0 : printf("Element #%lu\n", e);
2268 [ - - ]: 0 : printf("Relative error: %e\n", rel_err);
2269 [ - - ]: 0 : printf("Absolute error: %e\n\n", abs_err);
2270 : : }
2271 : : }
2272 : : }
2273 : :
2274 : : // Then, integrate explicitly on the remaining equations
2275 [ - - ]: 0 : for (std::size_t e=0; e<nelem; ++e)
2276 [ - - ]: 0 : for (std::size_t c=0; c<m_nnonstiffeq; ++c)
2277 : : {
2278 [ - - ]: 0 : for (std::size_t k=0; k<m_numEqDof[c]; ++k)
2279 : : {
2280 [ - - ]: 0 : auto rmark = m_nonStiffEqIdx[c]*rdof+k;
2281 [ - - ]: 0 : auto mark = m_nonStiffEqIdx[c]*ndof+k;
2282 : 0 : m_u(e, rmark) = m_un(e, rmark) + d->Dt() * (
2283 : 0 : expl_rkcoef[0][m_stage] * m_rhsprev(e, mark)/m_lhs(e, mark)
2284 : 0 : + expl_rkcoef[1][m_stage] * m_rhs(e, mark)/m_lhs(e, mark));
2285 [ - - ]: 0 : if(fabs(m_u(e, rmark)) < 1e-16)
2286 : 0 : m_u(e, rmark) = 0;
2287 : : }
2288 : : }
2289 : : }
2290 : : else {
2291 : : // For last stage just use all previously computed stages
2292 : 0 : const auto nelem = myGhosts()->m_fd.Esuel().size()/4;
2293 [ - - ]: 0 : for (std::size_t e=0; e<nelem; ++e)
2294 : : {
2295 : : // First integrate explicitly on nonstiff equations
2296 [ - - ]: 0 : for (std::size_t c=0; c<m_nnonstiffeq; ++c)
2297 : : {
2298 [ - - ]: 0 : for (std::size_t k=0; k<m_numEqDof[c]; ++k)
2299 : : {
2300 [ - - ]: 0 : auto rmark = m_nonStiffEqIdx[c]*rdof+k;
2301 [ - - ]: 0 : auto mark = m_nonStiffEqIdx[c]*ndof+k;
2302 : 0 : m_u(e, rmark) = m_un(e, rmark) + d->Dt() * (
2303 : 0 : expl_rkcoef[0][m_stage] * m_rhsprev(e, mark)/m_lhs(e, mark)
2304 : 0 : + expl_rkcoef[1][m_stage] * m_rhs(e, mark)/m_lhs(e, mark));
2305 [ - - ]: 0 : if(fabs(m_u(e, rmark)) < 1e-16)
2306 : 0 : m_u(e, rmark) = 0;
2307 : : }
2308 : : }
2309 : : // Then, integrate the imex-equations
2310 [ - - ]: 0 : for (std::size_t ieq=0; ieq<m_nstiffeq; ++ieq)
2311 [ - - ]: 0 : for (std::size_t idof=0; idof<m_numEqDof[ieq]; ++idof)
2312 : : {
2313 [ - - ]: 0 : auto rmark = m_stiffEqIdx[ieq]*rdof+idof;
2314 [ - - ]: 0 : auto mark = m_stiffEqIdx[ieq]*ndof+idof;
2315 : 0 : m_u(e, rmark) = m_un(e, rmark)
2316 : 0 : + d->Dt() * (expl_rkcoef[0][m_stage]
2317 : 0 : * m_rhsprev(e,mark)/m_lhs(e,mark)
2318 : 0 : + expl_rkcoef[1][m_stage]
2319 : 0 : * m_rhs(e,mark)/m_lhs(e,mark)
2320 : 0 : + impl_rkcoef[0][m_stage]
2321 : 0 : * m_stiffrhsprev(e,ieq*ndof+idof)/m_lhs(e,mark)
2322 : 0 : + impl_rkcoef[1][m_stage]
2323 : 0 : * m_stiffrhs(e,ieq*ndof+idof)/m_lhs(e,mark) );
2324 [ - - ]: 0 : if(fabs(m_u(e, rmark)) < 1e-16)
2325 : 0 : m_u(e, rmark) = 0;
2326 : : }
2327 : : }
2328 : : }
2329 : 0 : }
2330 : :
2331 : : #include "NoWarning/dg.def.h"
|