TRIQS/nda 1.3.0
Multi-dimensional array library for C++
Loading...
Searching...
No Matches
basic_array_view.hpp
Go to the documentation of this file.
1// Copyright (c) 2019-2023 Simons Foundation
2//
3// Licensed under the Apache License, Version 2.0 (the "License");
4// you may not use this file except in compliance with the License.
5// You may obtain a copy of the License at
6//
7// http://www.apache.org/licenses/LICENSE-2.0.txt
8//
9// Unless required by applicable law or agreed to in writing, software
10// distributed under the License is distributed on an "AS IS" BASIS,
11// WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
12// See the License for the specific language governing permissions and
13// limitations under the License.
14//
15// Authors: Miguel Morales, Olivier Parcollet, Nils Wentzell
16
22#pragma once
23
24#include "./basic_functions.hpp"
25#include "./clef.hpp"
26#include "./concepts.hpp"
27#include "./declarations.hpp"
28#include "./exceptions.hpp"
29#include "./iterators.hpp"
30#include "./layout/for_each.hpp"
31#include "./layout/idx_map.hpp"
33#include "./layout/range.hpp"
34#include "./macros.hpp"
36#include "./mem/memcpy.hpp"
37#include "./mem/policies.hpp"
38#include "./traits.hpp"
39
40#include <itertools/itertools.hpp>
41
42#include <algorithm>
43#include <array>
44#include <cstring>
45#include <memory>
46#include <ranges>
47#include <type_traits>
48#include <utility>
49
50#ifdef NDA_ENFORCE_BOUNDCHECK
51#include <exception>
52#include <iostream>
53#endif // NDA_ENFORCE_BOUNDCHECK
54
55namespace std {
56
62 template <typename V1, int R1, typename LP1, char A1, typename AP1, typename OP1, typename V2, int R2, typename LP2, char A2, typename AP2,
63 typename OP2>
65
66} // namespace std
67
68namespace nda {
69
126 template <typename ValueType, int Rank, typename LayoutPolicy, char Algebra, typename AccessorPolicy, typename OwningPolicy>
128 // Compile-time checks.
129 static_assert((Algebra != 'N'), "Internal error in nda::basic_array_view: Algebra 'N' not supported");
130 static_assert((Algebra != 'M') or (Rank == 2), "Internal error in nda::basic_array_view: Algebra 'M' requires a rank 2 view");
131 static_assert((Algebra != 'V') or (Rank == 1), "Internal error in nda::basic_array_view: Algebra 'V' requires a rank 1 view");
132
133 public:
135 using value_type = ValueType;
136
138 using layout_policy_t = LayoutPolicy;
139
141 using layout_t = typename LayoutPolicy::template mapping<Rank>;
142
144 using accessor_policy_t = AccessorPolicy;
145
147 using owning_policy_t = OwningPolicy;
148
150 using storage_t = typename OwningPolicy::template handle<ValueType>;
151
154
156 static constexpr int rank = Rank;
157
158 private:
159 // Type of the view itself.
160 using self_t = basic_array_view;
161
162 // Constexpr variable that is true if the view is a view (always for basic_array_view).
163 static constexpr bool is_view = true;
164
165 // Constexpr variable that is true if the value_type is const.
166 static constexpr bool is_const = std::is_const_v<ValueType>;
167
168 // Memory layout of the view, i.e. the nda::idx_map.
169 layout_t lay;
170
171 // Memory handle of the view.
172 storage_t sto;
173
174 // Declare any nda::basic_array as a friend.
175 template <typename T, int R, typename L, char A, typename CP>
176 friend class basic_array;
177
178 // Declare any other nda::basic_array_view as a friend.
179 template <typename T, int R, typename L, char A, typename AP, typename OP>
180 friend class basic_array_view;
181
182 // Check the layout compatibility of this view with another layout.
183 template <typename L>
184 static constexpr bool requires_runtime_check = not layout_property_compatible(L::template mapping<Rank>::layout_prop, layout_t::layout_prop);
185
186 public:
187 // FIXME : TRIQS PORTING
188 // private constructor for the previous friend
197 basic_array_view(layout_t const &idxm, storage_t st) : lay(idxm), sto(std::move(st)) {}
198
199 public:
200 // backward : FIXME : temporary to be removed
202 [[deprecated]] auto as_array_view() { return basic_array_view<ValueType, Rank, LayoutPolicy, 'A', AccessorPolicy, OwningPolicy>{*this}; };
203
205 [[deprecated]] auto as_array_view() const {
206 return basic_array_view<const ValueType, Rank, LayoutPolicy, 'A', AccessorPolicy, OwningPolicy>{*this};
207 };
208
210 basic_array_view() = default;
211
214
217
227 template <MemoryArrayOfRank<Rank> A>
228 requires((get_layout_info<A>.stride_order == layout_t::stride_order_encoded)
229 and (std::is_same_v<std::remove_const_t<ValueType>, get_value_t<A>>)
230 and (std::is_const_v<ValueType> or !std::is_const_v<typename std::decay_t<A>::value_type>))
231 explicit(requires_runtime_check<typename std::decay_t<A>::layout_policy_t>)
232 basic_array_view(A &&a) noexcept // NOLINT (should we forward the reference?)
233 : lay(a.indexmap()), sto(a.storage()) {}
234
244 basic_array_view(std::array<long, Rank> const &shape, ValueType *p) noexcept : basic_array_view(layout_t{shape}, p) {}
245
255 basic_array_view(layout_t const &idxm, ValueType *p) noexcept : lay(idxm), sto{p} {}
256
263 template <size_t N>
264 requires(Rank == 1)
265 explicit basic_array_view(std::array<ValueType, N> &a) noexcept : basic_array_view{{long(N)}, a.data()} {}
266
273 template <size_t N>
274 requires(Rank == 1 and std::is_const_v<ValueType>)
275 explicit basic_array_view(std::array<std::remove_const_t<ValueType>, N> const &a) noexcept : basic_array_view{{long(N)}, a.data()} {}
276
283 template <std::ranges::contiguous_range R>
284 requires(Rank == 1 and not MemoryArray<R>
285 and (std::is_same_v<std::ranges::range_value_t<R>, ValueType> or std::is_same_v<const std::ranges::range_value_t<R>, ValueType>))
286 explicit basic_array_view(R &rg) noexcept : basic_array_view{{long(std::ranges::size(rg))}, std::to_address(std::begin(rg))} {}
287
297 assign_from_ndarray(rhs);
298 return *this;
299 }
300
310 template <ArrayOfRank<Rank> RHS>
311 basic_array_view &operator=(RHS const &rhs) noexcept {
312 static_assert(!is_const, "Cannot assign to an nda::basic_array_view with const value_type");
313 assign_from_ndarray(rhs);
314 return *this;
315 }
316
327 template <typename RHS>
328 basic_array_view &operator=(RHS const &rhs) noexcept
330 {
331 static_assert(!is_const, "Cannot assign to an nda::basic_array_view with const value_type");
332 assign_from_scalar(rhs);
333 return *this;
334 }
335
344 template <ArrayInitializer<basic_array_view> Initializer>
345 basic_array_view &operator=(Initializer const &initializer) noexcept {
346 EXPECTS(shape() == initializer.shape());
347 initializer.invoke(*this);
348 return *this;
349 }
350
365 template <typename T, int R, typename LP, char A, typename AP, typename OP>
367 static_assert(R == Rank, "Cannot rebind a view to another view of a different rank");
368 static_assert(std::is_same_v<std::remove_const_t<T>, std::remove_const_t<ValueType>>,
369 "Cannot rebind a view to another view with a different value_type (except for const)");
370 static constexpr bool same_type = std::is_same_v<T, ValueType>;
371 static_assert(same_type or is_const, "Cannot rebind a view with non-const value_type to another view with const value_type");
372 if constexpr (same_type) {
373 // FIXME Error message in layout error !
374 lay = v.lay;
375 sto = v.sto;
376 } else if constexpr (is_const) {
377 // the last if is always trivially true but in case of an error in the static_assert above,
378 // it improves the error message by not compiling the = afterwards
379 lay = layout_t{v.indexmap()};
380 sto = storage_t{v.storage()};
381 }
382 }
383
392 friend void swap(basic_array_view &a, basic_array_view &b) noexcept {
393 std::swap(a.lay, b.lay);
394 std::swap(a.sto, b.sto);
395 }
396
405 friend void deep_swap(basic_array_view a, basic_array_view b) noexcept {
406 auto tmp = make_regular(a);
407 a = b;
408 b = tmp;
409 }
410
411// include common functionality of arrays and views
412// Copyright (c) 2019-2024 Simons Foundation
413//
414// Licensed under the Apache License, Version 2.0 (the "License");
415// you may not use this file except in compliance with the License.
416// You may obtain a copy of the License at
417//
418// http://www.apache.org/licenses/LICENSE-2.0.txt
419//
420// Unless required by applicable law or agreed to in writing, software
421// distributed under the License is distributed on an "AS IS" BASIS,
422// WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
423// See the License for the specific language governing permissions and
424// limitations under the License.
425//
426// Authors: Thomas Hahn, Miguel Morales, Olivier Parcollet, Nils Wentzell
427
432[[nodiscard]] constexpr auto const &indexmap() const noexcept { return lay; }
433
438[[nodiscard]] storage_t const &storage() const & noexcept { return sto; }
439
444[[nodiscard]] storage_t &storage() & noexcept { return sto; }
445
450[[nodiscard]] storage_t storage() && noexcept { return std::move(sto); }
451
458[[nodiscard]] constexpr auto stride_order() const noexcept { return lay.stride_order; }
459
464[[nodiscard]] ValueType const *data() const noexcept { return sto.data(); }
465
470[[nodiscard]] ValueType *data() noexcept { return sto.data(); }
471
476[[nodiscard]] auto const &shape() const noexcept { return lay.lengths(); }
477
482[[nodiscard]] auto const &strides() const noexcept { return lay.strides(); }
483
488[[nodiscard]] long size() const noexcept { return lay.size(); }
489
494[[nodiscard]] long is_contiguous() const noexcept { return lay.is_contiguous(); }
495
500[[nodiscard]] bool empty() const { return sto.is_null(); }
501
503[[nodiscard]] bool is_empty() const noexcept { return sto.is_null(); }
504
509[[nodiscard]] long extent(int i) const noexcept {
510#ifdef NDA_ENFORCE_BOUNDCHECK
511 if (i < 0 || i >= rank) {
512 std::cerr << "Error in extent: Dimension " << i << " is incompatible with array of rank " << rank << std::endl;
513 std::terminate();
514 }
515#endif
516 return lay.lengths()[i];
517}
518
520[[nodiscard]] long shape(int i) const noexcept { return extent(i); }
521
526[[nodiscard]] auto indices() const noexcept { return itertools::product_range(shape()); }
527
532static constexpr bool is_stride_order_C() noexcept { return layout_t::is_stride_order_C(); }
533
538static constexpr bool is_stride_order_Fortran() noexcept { return layout_t::is_stride_order_Fortran(); }
539
549decltype(auto) operator()(_linear_index_t idx) const noexcept {
550 if constexpr (layout_t::layout_prop == layout_prop_e::strided_1d)
551 return sto[idx.value * lay.min_stride()];
552 else if constexpr (layout_t::layout_prop == layout_prop_e::contiguous)
553 return sto[idx.value];
554 else
555 static_assert(always_false<layout_t>, "Internal error in array/view: Calling this type with a _linear_index_t is not allowed");
556}
557
559decltype(auto) operator()(_linear_index_t idx) noexcept {
560 if constexpr (layout_t::layout_prop == layout_prop_e::strided_1d)
561 return sto[idx.value * lay.min_stride()];
562 else if constexpr (layout_t::layout_prop == layout_prop_e::contiguous)
563 return sto[idx.value];
564 else
565 static_assert(always_false<layout_t>, "Internal error in array/view: Calling this type with a _linear_index_t is not allowed");
566}
567
568private:
569// Constexpr variable that is true if bounds checking is disabled.
570#ifdef NDA_ENFORCE_BOUNDCHECK
571static constexpr bool has_no_boundcheck = false;
572#else
573static constexpr bool has_no_boundcheck = true;
574#endif
575
576public:
593template <char ResultAlgebra, bool SelfIsRvalue, typename Self, typename... Ts>
594FORCEINLINE static decltype(auto) call(Self &&self, Ts const &...idxs) noexcept(has_no_boundcheck) {
595 // resulting value type
596 using r_v_t = std::conditional_t<std::is_const_v<std::remove_reference_t<Self>>, ValueType const, ValueType>;
597
598 // behavior depends on the given arguments
599 if constexpr (clef::is_any_lazy<Ts...>) {
600 // if there are lazy arguments, e.g. as in A(i_) << i_, a lazy expression is returned
601 return clef::make_expr_call(std::forward<Self>(self), idxs...);
602 } else if constexpr (sizeof...(Ts) == 0) {
603 // if no arguments are given, a full view is returned
605 } else {
606 // otherwise we check the arguments and either access a single element or make a slice
607 static_assert(((layout_t::template argument_is_allowed_for_call_or_slice<Ts> + ...) > 0),
608 "Error in array/view: Slice arguments must be convertible to range, ellipsis, or long (or string if the layout permits it)");
609
610 // number of arguments convertible to long
611 static constexpr int n_args_long = (layout_t::template argument_is_allowed_for_call<Ts> + ...);
612
613 if constexpr (n_args_long == rank) {
614 // access a single element
615 long offset = self.lay(idxs...);
616 if constexpr (is_view or not SelfIsRvalue) {
617 // if the calling object is a view or an lvalue, we return a reference
618 return AccessorPolicy::template accessor<ValueType>::access(self.sto.data(), offset);
619 } else {
620 // otherwise, we return a copy of the value
621 return ValueType{self.sto[offset]};
622 }
623 } else {
624 // access a slice of the view/array
625 auto const [offset, idxm] = self.lay.slice(idxs...);
626 static constexpr auto res_rank = decltype(idxm)::rank();
627 // resulting algebra
628 static constexpr char newAlgebra = (ResultAlgebra == 'M' and (res_rank == 1) ? 'V' : ResultAlgebra);
629 // resulting layout policy
630 using r_layout_p = typename detail::layout_to_policy<std::decay_t<decltype(idxm)>>::type;
632 }
633 }
634}
635
636public:
658template <typename... Ts>
659FORCEINLINE decltype(auto) operator()(Ts const &...idxs) const & noexcept(has_no_boundcheck) {
660 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
661 "Error in array/view: Incorrect number of parameters in call operator");
662 return call<Algebra, false>(*this, idxs...);
663}
664
666template <typename... Ts>
667FORCEINLINE decltype(auto) operator()(Ts const &...idxs) & noexcept(has_no_boundcheck) {
668 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
669 "Error in array/view: Incorrect number of parameters in call operator");
670 return call<Algebra, false>(*this, idxs...);
671}
672
674template <typename... Ts>
675FORCEINLINE decltype(auto) operator()(Ts const &...idxs) && noexcept(has_no_boundcheck) {
676 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
677 "Error in array/view: Incorrect number of parameters in call operator");
678 return call<Algebra, true>(*this, idxs...);
679}
680
698template <typename T>
699decltype(auto) operator[](T const &idx) const & noexcept(has_no_boundcheck) {
700 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
701 return call<Algebra, false>(*this, idx);
702}
703
705template <typename T>
706decltype(auto) operator[](T const &x) & noexcept(has_no_boundcheck) {
707 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
708 return call<Algebra, false>(*this, x);
709}
710
712template <typename T>
713decltype(auto) operator[](T const &x) && noexcept(has_no_boundcheck) {
714 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
715 return call<Algebra, true>(*this, x);
716}
717
719static constexpr int iterator_rank = (has_strided_1d(layout_t::layout_prop) ? 1 : Rank);
720
723
726
727private:
728// Make an iterator for the view/array depending on its type.
729template <typename Iterator>
730[[nodiscard]] auto make_iterator(bool at_end) const noexcept {
731 if constexpr (iterator_rank == Rank) {
732 // multi-dimensional iterator
733 if constexpr (layout_t::is_stride_order_C()) {
734 // C-order case (array_iterator already traverses the data in C-order)
735 return Iterator{indexmap().lengths(), indexmap().strides(), sto.data(), at_end};
736 } else {
737 // general case (we need to permute the shape and the strides according to the stride order of the layout)
738 return Iterator{nda::permutations::apply(layout_t::stride_order, indexmap().lengths()),
739 nda::permutations::apply(layout_t::stride_order, indexmap().strides()), sto.data(), at_end};
740 }
741 } else {
742 // 1-dimensional iterator
743 return Iterator{std::array<long, 1>{size()}, std::array<long, 1>{indexmap().min_stride()}, sto.data(), at_end};
744 }
745}
746
747public:
749[[nodiscard]] const_iterator begin() const noexcept { return make_iterator<const_iterator>(false); }
750
752[[nodiscard]] const_iterator cbegin() const noexcept { return make_iterator<const_iterator>(false); }
753
755iterator begin() noexcept { return make_iterator<iterator>(false); }
756
758[[nodiscard]] const_iterator end() const noexcept { return make_iterator<const_iterator>(true); }
759
761[[nodiscard]] const_iterator cend() const noexcept { return make_iterator<const_iterator>(true); }
762
764iterator end() noexcept { return make_iterator<iterator>(true); }
765
778template <typename RHS>
779auto &operator+=(RHS const &rhs) noexcept {
780 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
781 return operator=(*this + rhs);
782}
783
796template <typename RHS>
797auto &operator-=(RHS const &rhs) noexcept {
798 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
799 return operator=(*this - rhs);
800}
801
814template <typename RHS>
815auto &operator*=(RHS const &rhs) noexcept {
816 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
817 return operator=((*this) * rhs);
818}
819
832template <typename RHS>
833auto &operator/=(RHS const &rhs) noexcept {
834 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
835 return operator=(*this / rhs);
836}
837
846template <std::ranges::contiguous_range R>
847auto &operator=(R const &rhs) noexcept
848 requires(Rank == 1 and not MemoryArray<R>)
849{
850 *this = basic_array_view{rhs};
851 return *this;
852}
853
854private:
855// Implementation of the assignment from an n-dimensional array type.
856template <typename RHS>
857void assign_from_ndarray(RHS const &rhs) { // FIXME noexcept {
858#ifdef NDA_ENFORCE_BOUNDCHECK
859 if (this->shape() != rhs.shape())
860 NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Size mismatch:"
861 << "\n LHS.shape() = " << this->shape() << "\n RHS.shape() = " << rhs.shape();
862#endif
863 // compile-time check if assignment is possible
864 static_assert(std::is_assignable_v<value_type &, get_value_t<RHS>>, "Error in assign_from_ndarray: Incompatible value types");
865
866 // are both operands nda::MemoryArray types?
867 static constexpr bool both_in_memory = MemoryArray<self_t> and MemoryArray<RHS>;
868
869 // do both operands have the same stride order?
870 static constexpr bool same_stride_order = get_layout_info<self_t>.stride_order == get_layout_info<RHS>.stride_order;
871
872 // prefer optimized options if possible
873 if constexpr (both_in_memory and same_stride_order) {
874 if (rhs.empty()) return;
875 // are both operands strided in 1d?
876 static constexpr bool both_1d_strided = has_layout_strided_1d<self_t> and has_layout_strided_1d<RHS>;
877 if constexpr (mem::on_host<self_t, RHS> and both_1d_strided) {
878 // vectorizable copy on host
879 for (long i = 0; i < size(); ++i) (*this)(_linear_index_t{i}) = rhs(_linear_index_t{i});
880 return;
882 // check for block-layout and use mem::memcpy2D if possible
883 auto bl_layout_dst = get_block_layout(*this);
884 auto bl_layout_src = get_block_layout(rhs);
885 if (bl_layout_dst && bl_layout_src) {
886 auto [n_bl_dst, bl_size_dst, bl_str_dst] = *bl_layout_dst;
887 auto [n_bl_src, bl_size_src, bl_str_src] = *bl_layout_src;
888 // check that the total memory size is the same
889 if (n_bl_dst * bl_size_dst != n_bl_src * bl_size_src) NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Incompatible block sizes";
890 // if either destination or source consists of a single block, we can chunk it up to make the layouts compatible
891 if (n_bl_dst == 1 && n_bl_src > 1) {
892 n_bl_dst = n_bl_src;
893 bl_size_dst /= n_bl_src;
894 bl_str_dst = bl_size_dst;
895 }
896 if (n_bl_src == 1 && n_bl_dst > 1) {
897 n_bl_src = n_bl_dst;
898 bl_size_src /= n_bl_dst;
899 bl_str_src = bl_size_src;
900 }
901 // copy only if block-layouts are compatible, otherwise continue to fallback
902 if (n_bl_dst == n_bl_src && bl_size_dst == bl_size_src) {
903 mem::memcpy2D<mem::get_addr_space<self_t>, mem::get_addr_space<RHS>>((void *)data(), bl_str_dst * sizeof(value_type), (void *)rhs.data(),
904 bl_str_src * sizeof(value_type), bl_size_src * sizeof(value_type),
905 n_bl_src);
906 return;
907 }
908 }
909 }
910 }
911 // otherwise fallback to elementwise assignment
913 NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Fallback to elementwise assignment not implemented for arrays/views on the GPU";
914 }
915 nda::for_each(shape(), [this, &rhs](auto const &...args) { (*this)(args...) = rhs(args...); });
916}
917
918// Implementation to fill a view/array with a constant scalar value.
919template <typename Scalar>
920void fill_with_scalar(Scalar const &scalar) noexcept {
921 // we make a special implementation if the array is strided in 1d or contiguous
922 if constexpr (has_layout_strided_1d<self_t>) {
923 const long L = size();
924 auto *__restrict const p = data(); // no alias possible here!
925 if constexpr (has_contiguous_layout<self_t>) {
926 for (long i = 0; i < L; ++i) p[i] = scalar;
927 } else {
928 const long stri = indexmap().min_stride();
929 const long Lstri = L * stri;
930 for (long i = 0; i < Lstri; i += stri) p[i] = scalar;
931 }
932 } else {
933 // no compile-time memory layout guarantees
934 for (auto &x : *this) x = scalar;
935 }
936}
937
938// Implementation of the assignment from a scalar value.
939template <typename Scalar>
940void assign_from_scalar(Scalar const &scalar) noexcept {
941 static_assert(!is_const, "Error in assign_from_ndarray: Cannot assign to a const view");
942 if constexpr (Algebra != 'M') {
943 // element-wise assignment for non-matrix algebras
944 fill_with_scalar(scalar);
945 } else {
946 // a scalar has to be interpreted as a unit matrix for matrix algebras (the scalar in the shortest diagonal)
947 // FIXME : A priori faster to put 0 everywhere and then change the diag to avoid the if.
948 // FIXME : Benchmark and confirm.
950 fill_with_scalar(0);
951 else
952 fill_with_scalar(Scalar{0 * scalar}); // FIXME : improve this
953 const long imax = std::min(extent(0), extent(1));
954 for (long i = 0; i < imax; ++i) operator()(i, i) = scalar;
955 }
956}
957 };
958
959 // Class template argument deduction guides.
960 template <MemoryArray A>
961 basic_array_view(A &&a)
962 -> basic_array_view<std::conditional_t<std::is_const_v<std::remove_reference_t<A>>, const typename std::decay_t<A>::value_type,
963 typename std::decay_t<A>::value_type>,
964 get_rank<A>, typename std::decay_t<A>::layout_policy_t, get_algebra<A>, default_accessor, borrowed<mem::get_addr_space<A>>>;
965
966 template <typename V, size_t R>
967 basic_array_view(std::array<V, R> &a)
968 -> basic_array_view<V, 1, nda::basic_layout<nda::static_extents(R), nda::C_stride_order<1>, nda::layout_prop_e::contiguous>, 'V',
969 default_accessor, borrowed<>>;
970
971 template <typename V, size_t R>
972 basic_array_view(std::array<V, R> const &a)
973 -> basic_array_view<const V, 1, nda::basic_layout<nda::static_extents(R), nda::C_stride_order<1>, nda::layout_prop_e::contiguous>, 'V',
974 default_accessor, borrowed<>>;
975
976 template <std::ranges::contiguous_range R>
977 basic_array_view(R &r) -> basic_array_view<std::conditional_t<std::is_const_v<R>, const typename R::value_type, typename R::value_type>, 1,
978 C_layout, 'V', default_accessor, borrowed<>>;
979
980} // namespace nda
Provides definitions and type traits involving the different memory address spaces supported by nda.
void swap(nda::basic_array_view< V1, R1, LP1, A1, AP1, OP1 > &a, nda::basic_array_view< V2, R2, LP2, A2, AP2, OP2 > &b)=delete
std::swap is deleted for nda::basic_array_view.
Provides basic functions to create and manipulate arrays and views.
Iterator for nda::basic_array and nda::basic_array_view types.
A generic view of a multi-dimensional array.
const_iterator end() const noexcept
Get a const iterator to the end of the view/array.
ValueType const * data() const noexcept
Get a pointer to the actual data (in general this is not the beginning of the memory block for a view...
static constexpr bool is_stride_order_C() noexcept
Is the stride order of the view/array in C-order?
iterator begin() noexcept
Get an iterator to the beginning of the view/array.
ValueType * data() noexcept
Get a pointer to the actual data (in general this is not the beginning of thr memory block for a view...
basic_array_view & operator=(RHS const &rhs) noexcept
Assignment operator makes a deep copy of the contents of an nda::ArrayOfRank object.
typename OwningPolicy::template handle< ValueType > storage_t
Type of the memory handle (see Handles).
auto & operator/=(RHS const &rhs) noexcept
Division assignment operator.
static constexpr int rank
Number of dimensions of the view.
auto const & shape() const noexcept
Get the shape of the view/array.
static __inline__ decltype(auto) call(Self &&self, Ts const &...idxs) noexcept(has_no_boundcheck)
Implementation of the function call operator.
basic_array_view(layout_t const &idxm, ValueType *p) noexcept
Construct a view from a bare pointer to some contiguous data and a memory layout.
basic_array_view(R &rg) noexcept
Construct a 1-dimensional view of a general contiguous range.
basic_array_view & operator=(basic_array_view const &rhs) noexcept
Copy assignment operator makes a deep copy of the contents of the view.
basic_array_view(std::array< ValueType, N > &a) noexcept
Construct a 1-dimensional view of a std::array.
basic_array_view & operator=(Initializer const &initializer) noexcept
Assignment operator uses an nda::ArrayInitializer to assign to the view.
auto const & strides() const noexcept
Get the strides of the view/array (see nda::idx_map for more details on how we define strides).
long shape(int i) const noexcept
storage_t storage() &&noexcept
Get the data storage of the view/array.
typename LayoutPolicy::template mapping< Rank > layout_t
Type of the memory layout (an nda::idx_map).
auto & operator+=(RHS const &rhs) noexcept
Addition assignment operator.
auto indices() const noexcept
Get a range that generates all valid index tuples.
basic_array_view()=default
Default constructor constructs an empty view with a default constructed memory handle and layout.
long is_contiguous() const noexcept
Is the memory layout of the view/array contiguous?
auto & operator=(R const &rhs) noexcept
Assignment operator makes a deep copy of a general contiguous range and assigns it to the 1-dimension...
storage_t & storage() &noexcept
Get the data storage of the view/array.
static constexpr bool is_stride_order_Fortran() noexcept
Is the stride order of the view/array in Fortran-order?
auto & operator*=(RHS const &rhs) noexcept
Multiplication assignment operator.
basic_array_view(std::array< std::remove_const_t< ValueType >, N > const &a) noexcept
Construct a 1-dimensional view of a std::array.
friend void deep_swap(basic_array_view a, basic_array_view b) noexcept
Swap two views by swapping their data.
iterator end() noexcept
Get an iterator to the end of the view/array.
ValueType value_type
Type of the values in the view (might be const).
long size() const noexcept
Get the total size of the view/array.
auto & operator-=(RHS const &rhs) noexcept
Subtraction assignment operator.
bool empty() const
Is the view/array empty?
basic_array_view & operator=(RHS const &rhs) noexcept
Assignment operator assigns a scalar to the view.
basic_array_view(std::array< long, Rank > const &shape, ValueType *p) noexcept
Construct a view from a bare pointer to some contiguous data and a shape.
OwningPolicy owning_policy_t
Type of the owning policy (see Memory policies).
LayoutPolicy layout_policy_t
Type of the memory layout policy (see Layout policies).
bool is_empty() const noexcept
friend void swap(basic_array_view &a, basic_array_view &b) noexcept
Swap two views by swapping their memory handles and layouts.
constexpr auto stride_order() const noexcept
Get the stride order of the memory layout of the view/array (see nda::idx_map for more details on how...
const_iterator cbegin() const noexcept
Get a const iterator to the beginning of the view/array.
basic_array_view(layout_t const &idxm, storage_t st)
Construct a view from a given layout and memory handle.
static constexpr int iterator_rank
Rank of the nda::array_iterator for the view/array.
AccessorPolicy accessor_policy_t
Type of the accessor policy (see e.g. nda::default_accessor).
basic_array_view(basic_array_view &&)=default
Default move constructor moves the memory handle and layout.
void rebind(basic_array_view< T, R, LP, A, AP, OP > v) noexcept
Rebind the current view to another view.
basic_array_view(basic_array_view const &)=default
Default copy constructor copies the memory handle and layout.
long extent(int i) const noexcept
Get the extent of the ith dimension.
constexpr auto const & indexmap() const noexcept
Get the memory layout of the view/array.
const_iterator begin() const noexcept
Get a const iterator to the beginning of the view/array.
const_iterator cend() const noexcept
Get a const iterator to the end of the view/array.
storage_t const & storage() const &noexcept
Get the data storage of the view/array.
A generic multi-dimensional array.
Includes all clef relevant headers.
Check if a given type satisfies the memory array concept.
Definition concepts.hpp:248
Provides concepts for the nda library.
Provides various convenient aliases and helper functions for nda::basic_array and nda::basic_array_vi...
Provides a custom runtime error class and macros to assert conditions and throw exceptions.
Provides for_each functions for multi-dimensional arrays/views.
decltype(auto) make_regular(A &&a)
Make a given object regular.
constexpr uint64_t static_extents(int i0, Is... is)
Encode the given shape into a single integer using the nda::encode function.
constexpr bool have_same_value_type_v
Constexpr variable that is true if all types in As have the same value type as A0.
Definition traits.hpp:196
constexpr int get_rank
Constexpr variable that specifies the rank of an nda::Array or of a contiguous 1-dimensional range.
Definition traits.hpp:136
std::decay_t< decltype(get_first_element(std::declval< A const >()))> get_value_t
Get the value type of an array/view or a scalar type.
Definition traits.hpp:192
auto make_expr_call(F &&f, Args &&...args)
Create a function call expression from a callable object and a list of arguments.
Definition make_lazy.hpp:74
constexpr bool is_any_lazy
Constexpr variable that is true if any of the given types is lazy.
Definition utils.hpp:157
constexpr uint64_t C_stride_order
C/Row-major stride order.
Definition idx_map.hpp:65
constexpr bool layout_property_compatible(layout_prop_e from, layout_prop_e to)
Checks if two layout properties are compatible with each other.
Definition traits.hpp:237
constexpr bool ellipsis_is_present
Constexpr variable that is true if the parameter pack Args contains an nda::ellipsis.
Definition range.hpp:69
constexpr bool has_strided_1d(layout_prop_e lp)
Checks if a layout property has the strided_1d property.
Definition traits.hpp:266
__inline__ void for_each(std::array< Int, R > const &shape, F &&f)
Loop over all possible index values of a given shape and apply a function to them.
Definition for_each.hpp:129
constexpr bool has_layout_strided_1d
Constexpr variable that is true if type A has the strided_1d nda::layout_prop_e guarantee.
Definition traits.hpp:334
auto get_block_layout(A const &a)
Check if a given nda::MemoryArray has a block-strided layout.
constexpr layout_info_t get_layout_info
Constexpr variable that specifies the nda::layout_info_t of type A.
Definition traits.hpp:321
constexpr bool has_contiguous_layout
Constexpr variable that is true if type A has the contiguous nda::layout_prop_e guarantee.
Definition traits.hpp:330
static constexpr bool on_device
Constexpr variable that is true if all given types have a Device address space.
static constexpr AddressSpace get_addr_space
Variable template providing the address space for different types.
static constexpr bool on_host
Constexpr variable that is true if all given types have a Host address space.
void memcpy2D(void *dest, size_t dpitch, const void *src, size_t spitch, size_t width, size_t height)
Call CUDA's cudaMemcpy2D function or simulate its behavior on the Host based on the given address spa...
Definition memcpy.hpp:84
constexpr std::array< T, N > apply(std::array< Int, N > const &p, std::array< T, N > const &a)
Apply a permutation to a std::array.
static constexpr bool always_false
Constexpr variable that is always false regardless of the types in Ts (used to trigger static_assert)...
Definition traits.hpp:71
constexpr bool is_scalar_for_v
Constexpr variable used to check requirements when initializing an nda::basic_array or nda::basic_arr...
Definition traits.hpp:93
constexpr bool is_scalar_or_convertible_v
Constexpr variable that is true if type S is a scalar type (see nda::is_scalar_v) or if a std::comple...
Definition traits.hpp:86
Provides a class that maps multi-dimensional indices to a linear index and vice versa.
Provides an iterator for nda::basic_array and nda::basic_array_view types.
Macros used in the nda library.
Defines various memory handling policies.
Provides a generic memcpy and memcpy2D function for different address spaces.
Provides utilities to work with permutations and to compactly encode/decode std::array objects.
Includes the itertools header and provides some additional utilities.
A small wrapper around a single long integer to be used as a linear index.
Definition traits.hpp:343
Contiguous layout policy with C-order (row-major order).
Definition policies.hpp:47
Generic layout policy with arbitrary order.
Definition policies.hpp:115
Memory policy using an nda::mem::handle_heap.
Definition policies.hpp:44
uint64_t stride_order
Stride order of the array/view.
Definition traits.hpp:297
Provides type traits for the nda library.