Skip to content

Commit e688660

Browse files
Merge pull request #985 from gridap/add-missing-api
Release Gridap 0.18
2 parents 4cf9e8a + 53367a7 commit e688660

36 files changed

+548
-286
lines changed

NEWS.md

+17-1
Original file line numberDiff line numberDiff line change
@@ -5,7 +5,23 @@ All notable changes to this project will be documented in this file.
55
The format is based on [Keep a Changelog](https://keepachangelog.com/en/1.0.0/),
66
and this project adheres to [Semantic Versioning](https://semver.org/spec/v2.0.0.html).
77

8-
## [0.17.23] - 2024-01-28
8+
## [0.18.0] - 2024-03-22
9+
10+
### Breaking
11+
12+
- ODE module extensive refactor. Breaking changes! See docs and PR for details. Since PR[965](https://github.com/gridap/Gridap.jl/pull/965).
13+
- Fixed name clash with `Statistics.mean`. Since PR[#988](https://github.com/gridap/Gridap.jl/pull/988).
14+
- Deprecated `SubVector` in favor of Julia's `view`. Since PR[#989](https://github.com/gridap/Gridap.jl/pull/989).
15+
16+
### Added
17+
18+
- Added some missing API methods to `Assemblers` and `MultiField`. Since PR[#985](https://github.com/gridap/Gridap.jl/pull/985).
19+
20+
### Fixed
21+
22+
- Fix when evaluating `\circ` operator with `CellState`. Since PR[#987](https://github.com/gridap/Gridap.jl/pull/987).
23+
24+
## [0.17.23] - 2024-01-28
925

1026
### Changed
1127

Project.toml

+2-1
Original file line numberDiff line numberDiff line change
@@ -1,7 +1,7 @@
11
name = "Gridap"
22
uuid = "56d4f2e9-7ea1-5844-9cf6-b9c51ca7ce8e"
33
authors = ["Santiago Badia <santiago.badia@monash.edu>", "Francesc Verdugo <f.verdugo.rojano@vu.nl>", "Alberto F. Martin <alberto.f.martin@anu.edu.au>"]
4-
version = "0.17.23"
4+
version = "0.18.0"
55

66
[deps]
77
AbstractTrees = "1520ce14-60c1-5f80-bbc7-55ef81b5835c"
@@ -26,6 +26,7 @@ Random = "9a3f8284-a2c9-5f02-9a11-845980a1fd5c"
2626
SparseArrays = "2f01184e-e22b-5df5-ae63-d93ebab69eaf"
2727
SparseMatricesCSR = "a0a7dd2c-ebf4-11e9-1f05-cf50bc540ca1"
2828
StaticArrays = "90137ffa-7385-5640-81b9-e52037218182"
29+
Statistics = "10745b16-79ce-11e8-11f9-7d13ad32a3b2"
2930
Test = "8dfed614-e22c-5e08-85e1-65c5234f0b40"
3031
WriteVTK = "64499a7a-5c06-52f2-abe2-ccb03c286192"
3132

docs/src/ODEs.md

+15-1
Original file line numberDiff line numberDiff line change
@@ -91,7 +91,7 @@ A `TransientTrialFESpace` can be evaluated at any time derivative order, and the
9191

9292
For example, the following creates a transient `FESpace` and evaluates its first two time derivatives.
9393
```
94-
g(t::Real) = x -> x[1] + x[2] * t
94+
g(t) = x -> x[1] + x[2] * t
9595
V = FESpace(model, reffe, dirichlet_tags="boundary")
9696
U = TransientTrialFESpace (V, g)
9797
@@ -155,6 +155,16 @@ TransientLinearFEOperator((stiffness, mass), res, U, V, constant_forms=(false, t
155155
```
156156
If $\kappa$ is constant, the keyword `constant_forms` could be replaced by `(true, true)`.
157157

158+
## The `TimeSpaceFunction` constructor
159+
Apply differential operators on a function that depends on time and space is somewhat cumbersome. Let `f` be a function of time and space, and `g(t) = x -> f(t, x)` (as in the prescription of the boundary conditions `g` above). Applying the operator $\partial_{t} - \Delta$ to `g` and evaluating at $(t, x)$ is written `∂t(g)(t)(x) - Δ(g(t))(x)`.
160+
161+
The constructor `TimeSpaceFunction` allows for simpler notations: let `h = TimeSpaceFunction(g)`. The object `h` is a functor that supports the notations
162+
* `op(h)`: a `TimeSpaceFunction` representing both `t -> x -> op(f)(t, x)` and `(t, x) -> op(f)(t, x)`,
163+
* `op(h)(t)`: a function of space representing `x -> op(f)(t, x)`
164+
* `op(h)(t, x)`: the quantity `op(f)(t, x)` (this notation is equivalent to `op(h)(t)(x)`),
165+
166+
for all spatial and temporal differential operator, i.e. `op` in `(time_derivative, gradient, symmetric_gradient, divergence, curl, laplacian)` and their symbolic aliases (`∂t`, `∂tt`, ``, ...). The operator above applied to `h` and evaluated at `(t, x)` can be conveniently written `∂t(h)(t, x) - Δ(h)(t, x)`.
167+
158168
## Solver and solution
159169
The next step is to choose an ODE solver (see below for a full list) and specify the boundary conditions. The solution can then be iterated over until the final time is reached.
160170

@@ -252,6 +262,8 @@ By looking at the behaviour of the stability function at infinity, we find that
252262
## Generalised- $\alpha$ scheme for first-order ODEs
253263
This scheme relies on the state vector $\\{\boldsymbol{s}(t)\\} = \\{\boldsymbol{u}(t), \partial_{t} \boldsymbol{u}(t)\\}$. In particular, it needs a nontrivial starting procedure that evaluates $\partial_{t} \boldsymbol{u}(t_{0})$ by enforcing a zero residual at $t_{0}$. The finaliser can still return the first vector of the state vectors. For convenience, let $\partial_{t} \boldsymbol{u}\_{n}$ denote the approximation $\partial_{t} \boldsymbol{u}(t_{n})$.
254264

265+
> Alternatively, the initial velocity can be provided manually: when calling `solve(odeslvr, tfeop, t0, tF, uhs0)`, set `uhs0 = (u0, v0, a0)` instead of `uhs0 = (u0, v0)`. This is useful when enforcing a zero initial residual would lead to a singular system.
266+
255267
This method extends the $\theta$-method by considering the two-point quadrature rule $$\boldsymbol{u}(t_{n+1}) = \boldsymbol{u}\_{n} + \int_{t_{n}}^{t_{n+1}} \partial_{t} \boldsymbol{u}(t) \ \mathrm{d} t \approx \boldsymbol{u}\_{n} + h_{n} [(1 - \gamma) \partial_{t} \boldsymbol{u}(t_{n}) + \gamma \partial_{t} \boldsymbol{u}(t_{n+1})],$$
256268
where $0 \leq \gamma \leq 1$ is a free parameter. The question is now how to estimate $\partial_{t} \boldsymbol{u}(t_{n+1})$. This is achieved by enforcing a zero residual at $t_{n + \alpha_{F}} \doteq (1 - \alpha_{F}) t_{n} + \alpha_{F} t_{n+1}$, where $0 \leq \alpha_{F} \leq 1$ is another free parameter. The value of $\boldsymbol{u}$ at that time, $\boldsymbol{u}\_{n + \alpha_{F}}$, is obtained by the same linear combination of $\boldsymbol{u}$ at $t_{n}$ and $t_{n+1}$. Regarding $\partial_{t} \boldsymbol{u}$, it is taken as a linear combination weighted by another free parameter $0 < \alpha_{M} \leq 1$ of the time derivative at times $t_{n}$ and $t_{n+1}$. Note that $\alpha_{M}$ cannot be zero. Altogether, we have defined the discrete operators
257269
```math
@@ -399,6 +411,8 @@ We note that the first column of the matrix and the first weight are all zero, s
399411
## Generalised- $\alpha$ scheme for second-order ODEs
400412
This scheme relies on the state vector $\\{\boldsymbol{s}(t)\\} = \\{\boldsymbol{u}(t), \partial_{t} \boldsymbol{u}(t), \partial_{tt} \boldsymbol{u}(t)\\}$. It needs a nontrivial starting procedure that evaluates $\partial_{tt} \boldsymbol{u}(t_{0})$ by enforcing a zero residual at $t_{0}$. The finaliser can still return the first vector of the state vectors. For convenience, let $\partial_{tt} \boldsymbol{u}\_{n}$ denote the approximation $\partial_{tt} \boldsymbol{u}(t_{n})$.
401413

414+
> The initial acceleration can alternatively be provided manually: when calling `solve(odeslvr, tfeop, t0, tF, uhs0)`, set `uhs0 = (u0, v0, a0)` instead of `uhs0 = (u0, v0)`. This is useful when enforcing a zero initial residual would lead to a singular system.
415+
402416
This method is built out of the following update rule
403417
```math
404418
\begin{align*}

src/Algebra/AlgebraInterfaces.jl

+7
Original file line numberDiff line numberDiff line change
@@ -298,6 +298,13 @@ function axpy_entries!(
298298
B
299299
end
300300

301+
function axpy_entries!::Number, A::T, B::T) where {T<:AbstractBlockMatrix}
302+
map(blocks(A), blocks(B)) do a, b
303+
axpy_entries!(α, a, b)
304+
end
305+
B
306+
end
307+
301308
#
302309
# Some API associated with assembly routines
303310
#

src/Arrays/Arrays.jl

+1-2
Original file line numberDiff line numberDiff line change
@@ -105,7 +105,6 @@ export find_local_index
105105

106106
export IdentityVector
107107

108-
export SubVector
109108
export pair_arrays
110109
export unpair_arrays
111110

@@ -162,7 +161,7 @@ include("KeyToValMaps.jl")
162161

163162
include("FilteredArrays.jl")
164163

165-
include("SubVectors.jl")
164+
include("SubVectors.jl") # Deprecated
166165

167166
include("ArrayPairs.jl")
168167

src/Arrays/PrintOpTrees.jl

-4
Original file line numberDiff line numberDiff line change
@@ -53,10 +53,6 @@ function get_children(n::TreeNode, a::LazyArray)
5353
(similar_tree_node(n,a.maps),map(i->similar_tree_node(n,i),a.args)...)
5454
end
5555

56-
function get_children(n::TreeNode, a::SubVector)
57-
(similar_tree_node(n,a.vector),)
58-
end
59-
6056
function get_children(n::TreeNode, a::Reindex)
6157
(similar_tree_node(n,a.values),)
6258
end

src/Arrays/SubVectors.jl

+2
Original file line numberDiff line numberDiff line change
@@ -5,6 +5,8 @@
55
pini::Int
66
pend::Int
77
end
8+
9+
`SubVector` is deprecated, use `view` instead.
810
"""
911
struct SubVector{T,A<:AbstractVector{T}} <: AbstractVector{T}
1012
vector::A

src/CellData/CellData.jl

+1
Original file line numberDiff line numberDiff line change
@@ -34,6 +34,7 @@ import Gridap.Geometry: get_triangulation
3434
import Gridap.TensorValues: inner, outer, double_contraction, symmetric_part
3535
import LinearAlgebra: det, tr, cross, dot, , rmul!
3636
import Base: inv, abs, abs2, *, +, -, /, adjoint, transpose, real, imag, conj
37+
import Statistics: mean
3738

3839
export gradient, ∇
3940
export ∇∇

src/FESpaces/Assemblers.jl

+22-3
Original file line numberDiff line numberDiff line change
@@ -197,7 +197,7 @@ end
197197

198198
"""
199199
"""
200-
function assemble_matrix_add!(mat,a::Assembler, matdata)
200+
function assemble_matrix_add!(mat,a::Assembler,matdata)
201201
@abstractmethod
202202
end
203203

@@ -215,11 +215,11 @@ end
215215

216216
"""
217217
"""
218-
function assemble_matrix_and_vector!(A,b,a::Assembler, data)
218+
function assemble_matrix_and_vector!(A,b,a::Assembler,data)
219219
@abstractmethod
220220
end
221221

222-
function assemble_matrix_and_vector_add!(A,b,a::Assembler, data)
222+
function assemble_matrix_and_vector_add!(A,b,a::Assembler,data)
223223
@abstractmethod
224224
end
225225

@@ -279,6 +279,17 @@ end
279279
# Some syntactic sugar for assembling from anonymous functions
280280
# and objects from which one can collect cell matrices/vectors
281281

282+
function allocate_matrix(f::Function,a::Assembler,U::FESpace,V::FESpace)
283+
v = get_fe_basis(V)
284+
u = get_trial_fe_basis(U)
285+
allocate_matrix(a,collect_cell_matrix(U,V,f(u,v)))
286+
end
287+
288+
function allocate_vector(f::Function,a::Assembler,V::FESpace)
289+
v = get_fe_basis(V)
290+
allocate_vector(a,collect_cell_vector(V,f(v)))
291+
end
292+
282293
function assemble_matrix(f::Function,a::Assembler,U::FESpace,V::FESpace)
283294
v = get_fe_basis(V)
284295
u = get_trial_fe_basis(U)
@@ -313,6 +324,14 @@ function assemble_matrix_and_vector!(f::Function,b::Function,M::AbstractMatrix,r
313324
assemble_matrix_and_vector!(M,r,a,collect_cell_matrix_and_vector(U,V,f(u,v),b(v)))
314325
end
315326

327+
function assemble_matrix_and_vector!(
328+
f::Function,b::Function,M::AbstractMatrix,r::AbstractVector,a::Assembler,U::FESpace,V::FESpace,uhd
329+
)
330+
v = get_fe_basis(V)
331+
u = get_trial_fe_basis(U)
332+
assemble_matrix_and_vector!(M,r,a,collect_cell_matrix_and_vector(U,V,f(u,v),b(v),uhd))
333+
end
334+
316335
function assemble_matrix(f,a::Assembler,U::FESpace,V::FESpace)
317336
assemble_matrix(a,collect_cell_matrix(U,V,f))
318337
end

src/MultiField/MultiFieldCellFields.jl

+5
Original file line numberDiff line numberDiff line change
@@ -40,3 +40,8 @@ Base.getindex(a::MultiFieldCellField,i::Integer) = a.single_fields[i]
4040
Base.iterate(a::MultiFieldCellField) = iterate(a.single_fields)
4141
Base.iterate(a::MultiFieldCellField,state) = iterate(a.single_fields,state)
4242
Base.length(a::MultiFieldCellField) = num_fields(a)
43+
44+
function LinearAlgebra.dot(a::MultiFieldCellField,b::MultiFieldCellField)
45+
@check num_fields(a) == num_fields(b)
46+
return sum(map(dot,a.single_fields,b.single_fields))
47+
end

src/MultiField/MultiFieldFEFunctions.jl

+5
Original file line numberDiff line numberDiff line change
@@ -68,3 +68,8 @@ Base.iterate(m::MultiFieldFEFunction) = iterate(m.single_fe_functions)
6868
Base.iterate(m::MultiFieldFEFunction,state) = iterate(m.single_fe_functions,state)
6969
Base.getindex(m::MultiFieldFEFunction,field_id::Integer) = m.single_fe_functions[field_id]
7070
Base.length(m::MultiFieldFEFunction) = num_fields(m)
71+
72+
function LinearAlgebra.dot(a::MultiFieldFEFunction,b::MultiFieldFEFunction)
73+
@check num_fields(a) == num_fields(b)
74+
return sum(map(dot,a.single_fe_functions,b.single_fe_functions))
75+
end

src/MultiField/MultiFieldFESpaces.jl

+30-3
Original file line numberDiff line numberDiff line change
@@ -137,6 +137,10 @@ function FESpaces.get_free_dof_ids(f::MultiFieldFESpace,::BlockMultiFieldStyle{N
137137
return BlockArrays.blockedrange(block_num_dofs)
138138
end
139139

140+
function FESpaces.zero_dirichlet_values(f::MultiFieldFESpace)
141+
map(zero_dirichlet_values,f.spaces)
142+
end
143+
140144
FESpaces.get_dof_value_type(f::MultiFieldFESpace{MS,CS,V}) where {MS,CS,V} = eltype(V)
141145

142146
FESpaces.get_vector_type(f::MultiFieldFESpace) = f.vector_type
@@ -262,6 +266,18 @@ function FESpaces.FEFunction(fe::MultiFieldFESpace, free_values)
262266
MultiFieldFEFunction(free_values,fe,blocks)
263267
end
264268

269+
function FESpaces.FEFunction(
270+
fe::MultiFieldFESpace, free_values::AbstractVector, dir_values::Vector{<:AbstractVector}
271+
)
272+
@check length(dir_values) == num_fields(fe)
273+
blocks = map(1:length(fe.spaces)) do i
274+
free_values_i = restrict_to_field(fe,free_values,i)
275+
dir_values_i = dir_values[i]
276+
FEFunction(fe.spaces[i],free_values_i,dir_values_i)
277+
end
278+
MultiFieldFEFunction(free_values,fe,blocks)
279+
end
280+
265281
function FESpaces.EvaluationFunction(fe::MultiFieldFESpace, free_values)
266282
blocks = map(1:length(fe.spaces)) do i
267283
free_values_i = restrict_to_field(fe,free_values,i)
@@ -297,7 +313,7 @@ function _restrict_to_field(f,
297313
offsets = _compute_field_offsets(U)
298314
pini = offsets[field] + 1
299315
pend = offsets[field] + num_free_dofs(U[field])
300-
SubVector(free_values,pini,pend)
316+
view(free_values,pini:pend)
301317
end
302318

303319
function _restrict_to_field(f,
@@ -316,7 +332,7 @@ function _restrict_to_field(f,
316332
offsets = compute_field_offsets(f,mfs)
317333
pini = offsets[field] + 1
318334
pend = offsets[field] + num_free_dofs(U[field])
319-
return SubVector(block_free_values,pini,pend)
335+
return view(block_free_values,pini:pend)
320336
end
321337

322338
"""
@@ -596,7 +612,18 @@ function FESpaces.interpolate_everywhere(objects, fe::MultiFieldFESpace)
596612
for (field, (U,object)) in enumerate(zip(fe.spaces,objects))
597613
free_values_i = restrict_to_field(fe,free_values,field)
598614
dirichlet_values_i = zero_dirichlet_values(U)
599-
uhi = interpolate_everywhere!(object, free_values_i,dirichlet_values_i,U)
615+
uhi = interpolate_everywhere!(object,free_values_i,dirichlet_values_i,U)
616+
push!(blocks,uhi)
617+
end
618+
MultiFieldFEFunction(free_values,fe,blocks)
619+
end
620+
621+
function FESpaces.interpolate_everywhere!(objects,free_values::AbstractVector,dirichlet_values::Vector,fe::MultiFieldFESpace)
622+
blocks = SingleFieldFEFunction[]
623+
for (field, (U,object)) in enumerate(zip(fe.spaces,objects))
624+
free_values_i = restrict_to_field(fe,free_values,field)
625+
dirichlet_values_i = dirichlet_values[field]
626+
uhi = interpolate_everywhere!(object,free_values_i,dirichlet_values_i,U)
600627
push!(blocks,uhi)
601628
end
602629
MultiFieldFEFunction(free_values,fe,blocks)

src/ODEs/ODESolvers/GeneralizedAlpha1.jl

+53-8
Original file line numberDiff line numberDiff line change
@@ -43,18 +43,27 @@ function GeneralizedAlpha1(
4343
GeneralizedAlpha1(sysslvr, dt, αf, αm, γ)
4444
end
4545

46+
# Default allocate_odecache without velocity
47+
function allocate_odecache(
48+
odeslvr::GeneralizedAlpha1, odeop::ODEOperator,
49+
t0::Real, us0::NTuple{1,AbstractVector}
50+
)
51+
u0 = us0[1]
52+
allocate_odecache(odeslvr, odeop, t0, (u0, u0))
53+
end
54+
4655
##################
4756
# Nonlinear case #
4857
##################
4958
function allocate_odecache(
5059
odeslvr::GeneralizedAlpha1, odeop::ODEOperator,
51-
t0::Real, us0::NTuple{1,AbstractVector}
60+
t0::Real, us0::NTuple{2,AbstractVector}
5261
)
53-
u0 = us0[1]
54-
us0N = (u0, u0)
62+
u0, v0 = us0[1], us0[2]
63+
us0N = (u0, v0)
5564
odeopcache = allocate_odeopcache(odeop, t0, us0N)
5665

57-
uα, vα = copy(u0), copy(u0)
66+
uα, vα = copy(u0), copy(v0)
5867

5968
sysslvrcache = nothing
6069
odeslvrcache = (uα, vα, sysslvrcache)
@@ -104,6 +113,24 @@ function ode_start(
104113
(state0, odecache)
105114
end
106115

116+
function ode_start(
117+
odeslvr::GeneralizedAlpha1, odeop::ODEOperator,
118+
t0::Real, us0::NTuple{2,AbstractVector},
119+
odecache
120+
)
121+
# Unpack inputs
122+
u0, v0 = us0[1], us0[2]
123+
124+
# Allocate state
125+
s0, s1 = copy(u0), copy(v0)
126+
127+
# Update state
128+
state0 = (s0, s1)
129+
130+
# Pack outputs
131+
(state0, odecache)
132+
end
133+
107134
function ode_march!(
108135
stateF::NTuple{2,AbstractVector},
109136
odeslvr::GeneralizedAlpha1, odeop::ODEOperator,
@@ -163,13 +190,13 @@ end
163190
###############
164191
function allocate_odecache(
165192
odeslvr::GeneralizedAlpha1, odeop::ODEOperator{<:AbstractLinearODE},
166-
t0::Real, us0::NTuple{1,AbstractVector}
193+
t0::Real, us0::NTuple{2,AbstractVector}
167194
)
168-
u0 = us0[1]
169-
us0N = (u0, u0)
195+
u0, v0 = us0[1], us0[2]
196+
us0N = (u0, v0)
170197
odeopcache = allocate_odeopcache(odeop, t0, us0N)
171198

172-
uα, vα = zero(u0), zero(u0)
199+
uα, vα = zero(u0), zero(v0)
173200

174201
constant_stiffness = is_form_constant(odeop, 0)
175202
constant_mass = is_form_constant(odeop, 1)
@@ -229,6 +256,24 @@ function ode_start(
229256
(state0, odecache)
230257
end
231258

259+
function ode_start(
260+
odeslvr::GeneralizedAlpha1, odeop::ODEOperator{<:AbstractLinearODE},
261+
t0::Real, us0::NTuple{2,AbstractVector},
262+
odecache
263+
)
264+
# Unpack inputs
265+
u0, v0 = us0[1], us0[2]
266+
267+
# Allocate state
268+
s0, s1 = copy(u0), copy(v0)
269+
270+
# Update state
271+
state0 = (s0, s1)
272+
273+
# Pack outputs
274+
(state0, odecache)
275+
end
276+
232277
function ode_march!(
233278
stateF::NTuple{2,AbstractVector},
234279
odeslvr::GeneralizedAlpha1, odeop::ODEOperator{<:AbstractLinearODE},

0 commit comments

Comments
 (0)