Next Article in Journal
Fluid Properties, Charging Stages, and Hydrocarbon Accumulation Process in the Pinghu Oil and Gas Field, Xihu Sag, East China Sea Shelf Basin
Previous Article in Journal
Robust Collision Avoidance for ASVs Using Deep Reinforcement Learning with Sim2Real Methods in Static Obstacle Environments
Previous Article in Special Issue
Reducing Collision Risks in Harbours with Mixed AIS and Non-AIS Traffic Using Augmented Reality and ANN
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Multi-Objective Optimization Design for Column Structures of the Semi-Submersible Drilling Platform Using a Hybrid Criteria-Based Parallel EGO Algorithm

1
School of Mechanical Science and Engineering, Huazhong University of Science and Technology, Wuhan 430074, China
2
National CAD Supported Software Engineering Centre, Huazhong University of Science and Technology, Wuhan 430074, China
3
School of Electromechanical and Automotive Engineering, Yantai University, Yantai 264005, China
*
Author to whom correspondence should be addressed.
J. Mar. Sci. Eng. 2025, 13(9), 1729; https://doi.org/10.3390/jmse13091729
Submission received: 11 July 2025 / Revised: 2 September 2025 / Accepted: 5 September 2025 / Published: 8 September 2025
(This article belongs to the Special Issue Recent Advances in Maritime Safety and Ship Collision Avoidance)

Abstract

In engineering design for semi-submersible drilling platforms, it is necessary to improve anti-collision performance by optimizing the platform’s column’ structure. However, collision is usually analyzed through numerical analysis methods such as finite element analysis, which comes with high calculation costs. The genetic algorithm (GA) and other traditional optimization methods require massive numerical simulations, with unacceptable computational complexity. To address the above problems, a parallel efficient global optimization (EGO) multi-objective algorithm, based on hybrid criteria for the Kriging approximate model, is put forward in this paper. The proposed algorithm was validated through six typical multi-objective optimization test functions. The results show that it is superior to classic EGO, in terms of both optimization results and computational efficiency. Lastly, the hybrid criterion-based parallel EGO algorithm proposed in this paper was employed for the anti-collision, lightweight design of the column of the first ice zone semi-submersible drilling platform in China. It was found that the anti-collision capacity of the platform column rose by 11.9% and the structural weight declined by 2.7 t in the optimized design, suggesting obvious optimization effects with respect to the original design.

1. Introduction

With the global economic boom driving steady growth in oil consumption, countries are increasingly turning to deep-sea oil development. As key offshore operation facilities for drilling and oil extraction, the number of semi-submersible platforms is rising alongside the offshore oil demand, leading to a higher risk of ship collisions [1,2]. Such collisions generate massive impact forces, causing severe structural damage to these large-scale facilities. Moreover, the harsh working environment of semi-submersible platforms makes component repair more difficult and costly. Thus, improving the platform’s anti-collision capacity during the design stage has become a crucial research focus. China’s “North Dragon” semi-submersible drilling platform, designed to meet Norwegian Maritime Directorate and offshore industry standards, operates in the North Sea and Barents Sea with a maximum water depth of 1200 m, maximum drilling depth of 8000 m, and service temperature of −25 °C. It can withstand once-in-a-century storms, features an advanced automated drilling system (boosting efficiency by 15% via parallel automatic pipe arranging), and is uniquely capable of Arctic operations—making structural optimization to enhance its anti-collision and working performance practically significant. Figure 1 displays the “North Dragon” semi-submersible drilling platform.
To study the dynamic response of large-scale structures to ship collisions, the nonlinear finite element method is widely used. It accounts for material nonlinearity, structural large deformation, local damage, and overall failure to obtain parameters like stress, strain, and knock-out in the collision area. Combined with internal and external mechanism analysis, it can accurately simulate collision processes, partially replacing ship model and real-ship tests. Zhou et al. [3] analyzed ship collision impacts on a 1018 m cable-stayed bridge via numerical simulation to validate Eurocode’s collision force accuracy; Storheim and Amdahl [4] performed nonlinear finite element modeling of a 7500-ton supply vessel to study the ship’s collision damage to floating semi-submersibles and fixed jackets; Sha et al. [5] optimized the design of a steel bridge girder through finite element analysis of ship–bridge collision structural responses; Rudan et al. [6] calibrated ship collision simulation parameters via finite element analysis of LPG ship–ferry collisions; and Fernandez et al. [7] compared supply vessel bow modeling methods through finite element analysis of supply vessel–FPSO collisions.
Despite their high accuracy and adaptability to complex scenarios, numerical analysis methods (e.g., finite element analysis) have high computational complexity and long cycles, especially in structural optimization, which requires numerous simulations and may even make optimization unfeasible. In simulation-based optimization, approximate models (e.g., polynomial regression surface (PRS) [8], Kriging [9,10], radial basis function (RBF) [11], multivariate adaptive regression splines (MARSs) [12], and inductive learning models [13]) construct input–output relationships via limited simulations to replace time-consuming black-box models.
Traditional surrogate-based optimization first builds surrogates for time-consuming objective/constraint functions, then optimizes them with meta-heuristic algorithms (e.g., genetic algorithms) [14]. Static surrogates need high accuracy across the entire design space (requiring many sampling points), while surrogate-assisted meta-heuristic algorithms [15] dynamically update surrogates but still rely on population evolution, leading to insignificant reductions in simulation time. In contrast, surrogate-based optimization algorithms (e.g., adaptive response surface method (ARSM) [16], efficient global optimization (EGO) [17], mode-pursuing sampling (MPS) [18]) explore the original problem by adding renewal points, integrating global/local search, and fully utilizing surrogate information, requiring fewer objective function calculations. Among these, EGO (based on Kriging) is widely studied due to its simple framework and high efficiency. Surrogate-based optimization approaches, such as Kriging-assisted EGO, have shown promise in reducing computational burden while maintaining accuracy. These methods are particularly valuable in contexts where high-fidelity simulations are required, such as in the vibration analysis of nanocomposite-enhanced shell structures [19,20].
The classic EGO algorithm [21] works as follows: it builds an initial Kriging model with sample points; then, it iteratively selects the point with the maximum expected improvement (EI) as the renewal point, calculates its true target value, and updates the model until optimization is achieved. In engineering, multi-objective optimization often relies on mature meta-heuristic algorithms (e.g., NSGA-II [22]). However, these require thousands of objective function calculations, rendering it unsuitable for time-consuming tasks. EGO’s efficiency in single-objective optimization has led to its application in multi-objective scenarios, mainly by extending single-objective EI to multi-objective EI: defining a multi-objective improvement function (e.g., Euler distance, maximum/minimum distance, hypervolume (HV)) to measure improvement on the non-dominated front, and then integrating it in the non-dominated area. Relevant research includes that by Keane [23] (Euler distance EI), Bautista [24] and Svenson [25] (maximum/minimum distance EI), and HV-based EI (initially a screening criterion [26], later used as an EGO update criterion [27]). Other up-to-date optimization schema include the Adam Optimizer [28,29]. The adaptive method optimizer is a stochastic gradient descent method that combines momentum and per-parameter learning rate scaling for the efficient and robust training of deep learning models in engineering.
The standard EGO is serial (with one renewal point per iteration), which makes it incompatible with prevalent parallel computing hardware. Parallel EGO selects multiple renewal points per iteration for parallel computing (on multiple computers/cores), accelerating convergence and reducing total optimization time. Though it requires more real target calculations, simultaneous computing shortens the length of time, i.e., it exchanges computing resources for time, which is engineering-significant given the abundant resources and valuable time.
In summary, two significant challenges arise when extending EGO to practical engineering design: (1) Engineering problems inherently involve multiple, often competing, objectives. While several multi-objective EI criteria have been proposed, each criterion has inherent biases. (2) The standard EGO algorithm is inherently serial. This serial nature fails to leverage the now-ubiquitous parallel computing resources, becoming a critical bottleneck for reducing total optimization time. To overcome these limitations, this paper puts forward a parallel EGO multi-objective algorithm based on the Kriging approximate model with hybrid criteria. Our primary motivation is to develop a more robust and efficient optimization scheme for expensive black-box functions by synergistically combining the strengths of multiple EI criteria to guide parallel sampling. The proposed algorithm introduces a novel hybrid criteria-based parallel sampling method, obtained by combining the merits of the Euler distance, maximum and minimum distance, and HV improvement criteria, taking as a basis the classic EGO algorithm. During the iteration process, the genetic algorithm (GA) is employed in parallel to achieve hybrid criteria-based optimal sampling, so that multiple optimizations, allowing the surrogate model to be gradually updated, can be determined in parallel in each iteration. The algorithm allows parallel computing on multiple machines or multiple cores, avoiding the shortcomings of iterating through serial sampling points, which makes falling into local optimizations more likely. Global optimizations can thus be easily achieved, improving computational efficiency.
This paper is structured as follows: The numerical simulation analysis of collisions between supply vessels and semi-submersible platforms is described in Section 2. Section 3 presents the research on the Kriging approximate model, and the hybrid criteria-based parallel EGO algorithm. The validation of the newly proposed method, using a typical multi-objective optimization test function, is delineated in Section 4. Section 5 presents the application of the method in the optimization design of anti-collision structures for the semi-submersible platform. Finally, Section 6 presents the conclusions of this work.

2. Numerical Simulation Analysis of Collisions Between Supply Vessels and Semi-Submersible Platforms

The dynamics of the internal structure and the external flow field involved in a collision between a supply vessel and a semi-submersible platform is a complex coupling process. Therefore, when studying these dynamics, emphasis is often placed on the key facts, while simplifications of other aspects in the calculations are necessarily made. In this paper, the added mass method is adopted to simulate the effects of the external fluid in the collision. Focusing on the working conditions typical of such a collision, the structural finite element model with the appropriate added mass factor, material parameter and grid density is used to study the resulting structural damage, and to analyze the factors affecting the anti-collision ability of the platform.

2.1. Finite Element Explicit Solution in the Collision

As the main method currently employed to study vessel collisions, the finite element numerical simulation method is not only capable of intuitively showing the composition of and damage to each structure in the collision, but the results obtained are also much more accurate than those that can be obtained with other methods.
The explicit solution finite element method is generally used for collision analysis. In the overall coordinate system, the explicit differential equation characterizing motion is given as follows:
M a n + C v n + K d n = F n e x t
where an, vn and dn are the acceleration, velocity and displacement vector, respectively, M, C and K represent the mass, damping, and rigidity matrix, respectively, and F n e x t stands for the external load.
Let F n int = C v n + K d n , F n r e = F n e x t - F n int ; Equation (1) can be written instead as follows:
M a n = F n r e
where F n int is the internal load of the structure, and F n r e is the surplus load of the structure.
A solvable linear equation requires the mass matrix to be a diagonal matrix, so the acceleration can be obtained as follows:
a n = M - 1 F n r e
The central difference method is employed for collisions. Thus, this method is used for time integration to obtain the velocity and the displacement, which can be shown as follows:
v n + 1 2 = v n 1 2 + a n Δ t n + 1 2 + Δ t n 1 2 / 2 d n + 1 = d n + v n + 1 2 Δ t n + 1 2
where the subscript n + 1 2 denotes the forward half-time step, while the subscript n - 1 2 denotes the backward half-time step. v n + 1 2 is the instantaneous velocity after the force acts and before the displacement is updated, representing the initial state of motion from t n to t n + 1 .
F n int integrates damping forces C v n and stiffness-induced forces K d n , and this grouping does not neglect damping forces but aligns with the explicit finite element framework for transient collision analysis, where short-duration impact responses prioritize computational efficiency. Damping forces contribute to energy dissipation and are non-negligible for dynamic equilibrium. Notably, Newton–Raphson schemes (common in implicit nonlinear static analysis) are not adopted here, as they require iterative-stiffness matrix inversion and are inefficient for transient collision problems; instead, the explicit central difference method is used to enable the fast calculation of transient accelerations and displacements.

2.2. Dimensions of Vessel Body and Platform and Finite Element Model

The platform under consideration has four columns and two lower floating bodies; its main dimensions are shown in Table 1. For the finite element structure of the semisubmersible drilling platform, the collided part of the column was modeled with plastic materials. Since the research on the collision damage and hydrodynamic characteristics focused on the column and lower floating body area, the structures of the deck and the above were simplified. In Figure 2, (a) represents the semi-submersible platform model, and (b) depicts the internal support structure of the column and the floating pontoon.
A collision between a vessel and semi-submersible platform is usually of one of the following main types: a bow collision, a side collision, or a stern collision. Since in the case of supply vessels, a bow collision with the platform column is much more dangerous than other collisions, this type was chosen as the research object in this paper. We mainly considered the collision force and collision depth of the semi-submersible platform. For this reason, only the bow part of the supply vessel was constructed when establishing the finite element model, and the model was simplified into a rigid model. The principal dimensions of the collision vessel considered in our study are shown in Table 2, and the finite element model is shown in Figure 3.
There are many factors at play in the collision between a vessel and a semisubmersible platform. In fact, there exist a variety of complex combinations of collision parameters, and it is impossible to take all the scenarios into consideration. Therefore, the most common collision parameter combination was chosen to study the collision performance of the structure, corresponding to the typical scenario in which the vessel collides with the platform column when moving forward with a velocity of 2 m/s. A finite element model of the head-on collision between a vessel and a platform column is shown in Figure 4.
It should be noted that a shell element was selected as the element type and the number of nodes was about 150,000.

2.3. Characteristic Analysis Under Typical Collision Working Conditions

The above condition was selected as a typical working condition to analyze the load, structural damage, and energy conversion during the collision. The collision depth changes under the typical working condition chosen, as shown in Figure 5. It can be seen that the collision depth of the supply vessel reaches a maximum of 987.5 m at 1.0 s after the collision, and the remaining energy of the vessel is not sufficient to resist the elastic deformation of the platform components. The effective contact area is then reduced by the reverse movement of the vessel, so the collision depth is gradually decreased.
The energy conversion duration curve of the collision system under the typical working condition is shown in Figure 6. It can be observed that the energy of the system continuously decreases, while the internal energy and hourglass energy constantly increase during the entire collision process. That is to say, the energy of the system is converted into internal energy and a small amount of hourglass energy. Meanwhile, combined with the trend of the curve changes, it can be observed that the total energy conversion follows the law of conservation of energy, as one part of the energy in the system decreases while the other part increases. The hourglass energy accounts for 4.6% of the internal energy of the platform, which meets the requirement of being below 5%. Therefore, the results of the nonlinear finite element dynamic analysis in this paper can be seen as reliable.
A structural damage cloud image of the semi-submersible platform at the maximum collision depth is shown in Figure 7. It can be seen the deformations of the platform are mainly distributed in the collision area by the bow of the supply vessel. The outer plate and its longitudinal beam mainly undergo tensile deformation and tear failure, and the horizontal frame, transverse bulkhead, vertical girder and other internal structures are bent, laterally bent and wrinkled, and even suffer tear failure.
From the above analysis, it could be understood that the structural deformations of the platform take place mainly in the collided column. Therefore, in order to improve the anti-collision ability of the platform, it is necessary to optimize the thickness of the structural components of the column that suffers the main deformations (including the outer plate, double shell, horizontal and longitudinal girders, bulkheads and other internal structures, as well as the longitudinal beam of the inner side of the outer plate).

3. Kriging Approximate Model and Parallel EGO Multi-Objective Algorithm Based on Hybrid Criteria

The collision analysis and structural optimization of supply vessels and semi-submersible platforms involve “expensive” simulation calculations, where traditional design tools and optimization algorithms are inefficient or time-prohibitive. Approximate model-based optimization offers an effective solution [30,31]; for instance, the Kriging model can approximate simulation models and combine with algorithms like genetic algorithms (GAs) to solve complex, expensive “black-box” function optimization or computer simulation-driven optimization problems [32,33].

3.1. Unconstrained Multi-Objective Optimization Problem

Platform structural design must first meet specification requirements, as well as multiple needs (equipment configuration, weight and center of gravity, stability, hydrodynamic performance, structural/fatigue strength). Early design stages already determine the key parameters (principal dimensions, basic structural forms, component plate thickness limits). Thus, for column anti-collision and lightweight optimization, the objectives are minimizing column structural weight and maximum collision depth under typical working conditions; the design variables are the component plate thicknesses; the constraints are the plate thickness limits. These constraints can be simplified to design variable boundaries, reducing the problem to an unconstrained multi-objective optimization, expressed as follows:
min F x = f 1 x , f 2 x , f m x x l x x u
where x is the design variable, xl and xu are, respectively, the upper and lower boundaries of the design variable, and F(x) represents the objective function. For most practical engineering problems, the objective function usually requires complex simulation calculations, and is also sometimes called the black-box function.
In the multi-objective optimization algorithm, the approximate model is used in F(x) for simulation as shown in the following formula.
min   F ^   x = f ^ 1 x , f ^ 2 x , f ^ m x x l x x u

3.2. Kriging Model

The Kriging model is an unbiased estimation model with minimal estimation variance, suitable for analyzing sample data correlation and predicting sample trends. In statistics, the Kriging model is also referred to as a Gaussian process model, as it treats the objective function as a Gaussian process (a normally distributed process) [34]. Assuming there exist N sample points x ( 1 ) , x ( 2 ) , x ( 3 ) , , x ( N ) , and the true objective values of these points are y ( 1 ) , y ( 2 ) , y ( 3 ) , , y ( N ) according to simulation calculations, the formula of the Kriging model is as follows [35]:
f ^ x = μ + z x
where µ is the mean value of the Gaussian process, and z(x) is a random process with a mean value of 0 and a variance of σ2. The correlation between any two sample points is as follows:
C o v z x ( i ) , z x ( j ) = exp k = 1 n θ k x k ( i ) x k ( j ) p k
where n is the number of design variables, θk and pk are undetermined coefficients, and k = 1, 2, ···, n. The parameter θk represents the kth dimensional weight of the design space, and the parameter pk represents the smoothness in the kth dimension of the design space.
Overall, the Kriging model has a total of 2 n + 2 undetermined parameters, namely µ, σ, θ1, ···, θn, p1,···, pn. These parameters can be obtained by maximizing the likelihood function of the sample points. Finally, the predicted value of any point x and the variance in the predicted value can be obtained as follows:
y ^ x = μ ^ + r T R 1 y l μ ^
s 2 x = σ ^ 2 1 r T R 1 r + 1 l T R 1 r 2 l T R 1 l
where μ ^ and σ ^ 2 are the estimated values of the undetermined parameters of µ and σ2, respectively, and they are given as follows:
μ ^ = l T R 1 y l T R 1 l
σ ^ 2 = ( y 1 μ ^ ) T R 1 ( y l μ ^ ) n
R is the correlation coefficient matrix of N × N, with the elements R i j = C o r r z x ( i ) , z x ( j ) ; r represents the N × 1 vector with the elements r i = C o r r z x , z x ( i ) ; y stands for the response value of the sample points, an N × 1 vector with the elements yi = y(i); and finally, l is the N × 1 vector, the elements of which are all 1 [36].

3.3. EGO Algorithm Based on the Kriging Approximate Model

The response value of the black-box function y ( x ) at test point x is regarded as a random variable of a normal distribution, conforming to the mean value y ^ ( x ) and the standard deviation s ( x ) , and with the following density function:
p d f ( Y ( x ) ) = 1 2 π s y ^ exp [ 1 2 ( Y ( x )   μ y ^ s y ^ ) 2 ]
As for the minimization, assuming that the optimal response value at the current test point is y min n = min { y 1 , y 2 , , y n } , the improvement in the predicted value of the Kriging model at the untested point x relative to y min n is given as I ( x ) = max ( y min n Y ( x ) ,   0 ) + . The EI of I(x) is calculated as follows:
E I x = 0 + I x p d f I x d I = y min n μ y ^ Φ y min n μ y ^ s y ^ + s y ^ ϕ y min n μ y ^ s y ^   ,   s y ^ > 0 0                                                                                                                                                             ,   s y ^ = 0
where Φ and ϕ are the standard normal distribution and density function, respectively. The smaller the predicted value μ y ^ of Kriging is than the current optimal value y min n , the larger the value of the first term of the EI criterion will be, indicating that this criterion tends to select new test points in the local optimal area where the predicted value μ y ^ is the smallest. In the unexplored area where the Kriging prediction standard deviation s y ^ is large, the value of the second term of the EI criterion is similarly large, which indicates that the EI criterion is adequate for exploring the potential optimal area.

3.4. Hybrid Criteria-Based Parallel EGO Multi-Objective Algorithm

Different from single-objective optimization, which seeks a single optimal solution, the purpose of multi-objective optimization is to obtain a set of representative Pareto optimal solutions (which we will call a Pareto Set). Since this set cannot be directly used to compare dimensions, optimizing the quality index of the Pareto Set is often carried out as a method to indirectly optimize multi-objective problems. A multi-objective improvement function must be proposed to extend the single-objective EGO algorithm for multi-objective optimization. The role of the improvement function is to describe the improvement degree of the non-dominated front, based on the objective vector of the defined research point in the objective space. The multi-dimensional calculation is then implemented to obtain the corresponding multi-objective improvement function.

3.4.1. HV Improvement Criterion

The HV index is commonly used to evaluate the comprehensive quality of the approximate Pareto Set. The HV index evaluation method represents the volume of the hypercube enclosed by the individual in the solution set and the reference point in the objective space. It is defined as follows:
H P F , r = V o l y R m P E y r
PF is the mapping of all Pareto optimal solutions of the objective function in the objective space, known as the Pareto front. For reference point r, this can be specified according to the actual situation, or using the corresponding component of the reference points, adopting the maximum value of each objective function on the initial test point set.
The HV improvement of the existing PF by the response value y (x) at the new test point x is defined as follows:
I h x = H P F y x , r H P F , r , y x P F                                 0                                                           , other
After constructing each objective function, the desired HV improvement of the objective function vector for untested point x is as follows:
E I h x = y ^ B I h x i = 1 m 1 s ϕ y i y ^ i s i d y i
where ϕ x ( y ^ ) is the joint probability density function of the objective function of the Kriging model, and
B R m
is the non-dominated domain defined by the reference point r. The larger the value of E I h x is, the more significant the improvement in the existing approximation PF at the new test point x will be.

3.4.2. Euler Distance Improvement Criterion

The notion of Euler distance was used by Keane [37] to define an improvement function, given as the smallest value of the Euler distance between the objective vector [y1 (x), y2 (x), ···, ym(x)] at the untested point x and the non-dominated front point.
I e x = min j = 1 k i = 1 m f i j y i x 2
According to the m dimensional normal distribution of the objective vector, the multi-objective EI criterion based on Euler distance improvement can be obtained as follows by integrating Ie(x) along the non-dominated area, represented below by the integral region A.
E I e x = y A I e x i = 1 m 1 s ϕ y i y ^ i s i d y i

3.4.3. Maximum Distance Improvement Criterion

The maximum and minimum distances are derived from the multi-objective evolution algorithm, and were first used by Bautista [24] to define the multi-objective improvement function as follows:
I m x = max j = 1 k min i = 1 m y i x f i j
According to the m-dimensional normal distribution of the objective vector, the multi-objective EI criterion based on maximum distance improvement can be written as follows, by integrating Im(x) along the non-dominated area:
E I m x = y A I m x i = 1 m 1 s ϕ y i y ^ i s i d y i

3.4.4. Proposed Algorithm

In this paper, a novel hybrid criterion-based parallel sampling method is proposed by combining the merits of the Euler distance, the maximum and minimum distances, and the HV improvement criteria, taking as a basis the classic EGO algorithm. Along the iterative process, the GA is employed in parallel to achieve hybrid criteria-based optimal sampling, so that the multiple optimizations are achieved in parallel in one iteration, allowing the surrogate model to be gradually updated. This algorithm enables parallel computing on multiple machines or multiple cores, avoiding the shortcomings of iterations through serial sampling points, which are prone to falling into a local optimization. In this way, our algorithm easily achieves global optimization, thus contributing to improve computational efficiency.
The algorithm consists of nine steps, organized in three principal phases. First, a Kriging surrogate model is constructed based on the set of sample points, as shown below in steps 1, 2 and 3 of the proposed algorithm. Second, a parallel hybrid criteria-based EI function is established, and the largest function value of each expected function is selected as the renewal point, as shown in steps 4 and 5. In each iteration, different EI functions should be optimized in parallel to select renewal points. Since the EI function is often multi-modal and highly nonlinear, it is usually necessary to use meta-heuristic optimization (possibly genetic) to find the maximum value. Since the EI function is an analytical expression, this calculation is so fast, compared with time-consuming simulation calculations, that its solution time can be seen as negligible. Third, the true response value of the renewal point is calculated and incorporated in the sample database, after which the approximate Pareto solution is obtained in the existing sample database, as shown in steps 6 and 7. In this way, the algorithm can obtain the Pareto solution by continuously selecting and calculating potential renewal points in parallel.
The overall process is outlined in Figure 8.
The steps of the proposed algorithm are described in detail in what follows:
  • Step 1: Obtain the initial sample ns. Generally, the number of initial sampling points is selected to be 10 n, where n is the design variable dimension. When the Latin HV experimental design method is selected for sampling, the rule of 10 n can be modified to facilitate the division of the design space. For example, in a 2D design space, let ns = 21; the division is 1/(ns − 1) = 0.5, and the number of initial samples is set to 11 n − 1. Meanwhile, k is an iteration counter, with an initial value of zero.
  • Step 2: Calculate the accurate value of the source function. “Expensive” calculations are executed on the new sampling point set by the simulation analysis program, in order to obtain this accurate value.
  • Step 3: Use sampling points and response values to construct or update the Kriging model.
  • Step 4: Construct the EI function in parallel, based on the HV, Euler distance, and maximum distance improvement criteria;
  • Step 5: Maximize the optimization of the EI function constructed in step 4, by using the parallel GA. The three high-EI points obtained are the renewal points x h k ,   x e k ,   x m k , with k being the number of iterations. Normalize the existing sample points, and then compute the Euclidean distance between each pair of sample points. Based on empirical evidence, set the minimum distance to 5% of the average distance between existing sample points. Should the distance between any newly added sample point and any existing sample point fall below this minimum distance, the newly added sample point should be discarded.
  • Step 6: Calculate the true response value of the renewal points. Parallel simulation analysis for the renewal points obtained in step 5 is executed to obtain their true values.
  • Step 7: Add the renewal point and its response value to the sample database, and update the Pareto front approximation accordingly.
  • Step 8: Identify the convergence. If the convergence criterion is met, exit the process. The convergence criterion can be set as reaching the maximum number of iterations nk, or based on the calculated HV index of the Pareto front approximation. The iterative process can be stopped if this does not increase in m consecutive iterations.
  • Step 9: If the convergence criterion is not met, go to step 3 and continue to the next iteration.

4. Analysis of Test Cases

A set of typical test functions were used to test the accuracy and efficiency of the algorithm proposed in this paper, and the corresponding results were compared with those obtained with the multi-objective EGO algorithm based on the single-objective EI criterion. The six test functions selected cover different types of typical test functions, all in the ZDT and DTLZ function series. ZDT1, ZDT2, and DTLZ2 correspond to the convex Pareto front and non-convex Pareto front, ZDT3 and DTLZ7 represent the discrete Pareto front, and DTLZ5 represents the curve Pareto front [23].
The number of design variables was set to n = 6 for all test cases, and the number of initial design sample points was 11 n − 1. The initial sample points were selected by the Latin hypercube sampling method, and the Kriging approximate model was created through the DACE (Design and Analysis of Computer Experiments) toolbox. Regpoly0 was set as the regression function, and corrgauss as the correlation function. The GA, with a population size of 150, maximum evolutional generation of 200, and stop algebra of 200, was used in the optimization of the EI function.
For the calculation of test cases, the algorithm proposed in this paper (EIp criterion) and the multi-objective EGO algorithm based on a single EI criterion [27] were separately applied, so as to compare the accuracy and efficiency of the algorithm proposed in this paper under the same number of sample points. In each algorithm, 215 samplings (50 iterations for the multi-objective EGO algorithm based on the EIp criterion, and 150 iterations for the other multi-objective EGO algorithms based on a single EI criterion), that is, 215 “expensive calculations”, were conducted in the same way. All experiments were carried out 30 times as per different initial schemes, so as to exclude the effect of initial sample points on experimental results. The comparisons among various algorithms were performed using the hypervolume (HV) of the Pareto front and the number of Pareto solutions obtained. The hypervolume can capture the closeness of the obtained solutions to the Pareto front as well as the spread property of the solutions. The reference points used for calculating the hypervolume values are set in Table 3 for each test problem. The hypervolume can capture the closeness of the obtained solutions to the Pareto front as well as the spread property of the solutions. The reference points used for calculating the hypervolume values are set in Table 3 for each test problem.
The HV of the approximate Pareto front and the number of the Pareto front approximations (NP) of test functions obtained by different algorithms are shown in Table 4. The larger HV of the approximate Pareto front and NP indicate higher quality.
The results revealed that under the same sample estimation, the HV of the approximate Pareto front obtained by the optimization algorithm proposed in this paper was superior to that obtained by other single-criterion optimization algorithms on all test functions. In addition, the NP obtained by the optimization algorithm proposed in this paper on all test functions was also significantly larger than that obtained by other single-criterion optimization algorithms. In actual engineering process applications, obtaining more Pareto front approximations allows engineers to have more choices, which is more propitious to obtaining optimization results in line with engineering practice. Therefore, the algorithm proposed in this paper is more advantageous in engineering applications.
Figure 9, Figure 10, Figure 11, Figure 12, Figure 13 and Figure 14 are boxplots of the HV of the approximate Pareto front and NP of all test functions obtained by separately running the multi-objective EGO algorithm based on the EIp criterion and single EI criterion for 30 times as per different initial schemes. Table 5, Table 6, Table 7, Table 8, Table 9 and Table 10 lists the corresponding standard deviations (SDs) and confidence intervals (CIs, based on 95% confidence intervals).
As seen in Figure 9, the boxplots for ZDT1 indicate that the EIp criterion algorithm achieves a marginally higher median HV and a significantly higher median NP compared to the single-criterion algorithms (EIe, EIh, EIm). The interquartile range (IQR) for HV appears similar across all algorithms, suggesting comparable variability in solution quality for this function. However, the spread of NP values is notably larger for the single-criterion methods. The data in Table 5 quantitatively supports the observations from Figure 9. The EIp criterion yields the highest mean HV (120.64) and mean NP (32). Crucially, it also demonstrates the lowest standard deviation (SD) for the HV (0.0074), indicating superior consistency and stability in performance across the 30 runs compared to the other criteria, which have higher SDs of the HV. The SD of the NP for EIp (5.19) is also the lowest, confirming more reliable convergence in terms of the number of solutions found.
As seen in Figure 10, for the ZDT2 test problem, the EIp criterion algorithm clearly outperforms the single-criterion ones. It demonstrates a noticeably higher median HV and a substantially higher median NP. The box for the NP using EIp is positioned much higher and shows less variability than those of the other algorithms, which cluster near lower values with similar spreads. Table 6 confirms the superiority of the EIp criterion on ZDT2. It achieves the highest mean HV (120.30) and mean NP (25). While the SDs for the HV are identical across all algorithms (0.0296), the dramatic difference in mean NP values (25 for EIp vs. 10, 5, and 15 for the others) highlights the significant advantage of the hybrid approach in finding a more extensive set of Pareto solutions for this problem.
As seen in Figure 11, the performance on ZDT3 shows a distinct advantage for the EIp criterion. Its median HV is significantly higher than those of the single-criterion algorithms. The NP values also show a positive trend, with EIp having a higher median and a wider distribution towards larger numbers of solutions compared to the others. The numerical results in Table 7 solidify the findings from Figure 11. The EIp criterion achieves the highest mean HV (128) by a considerable margin (compared to 127 and 128 ± 0.27 for EIm, for which the upper bound of the CI is just 128.27) and the highest mean NP (30). Although the SDs for NP are the same, the mean values for the single-criterion algorithms (15, 15, 20) are substantially lower than those of EIp, demonstrating its effectiveness on this problem with a discontinuous Pareto front.
As seen in Figure 12, for the three-objective DTLZ2 problem, the EIp criterion maintains a slight edge, showing a marginally higher median HV compared to the other algorithms. The median NP for EIp is also visibly higher, suggesting a better ability to approximate the entire Pareto front in 3D space. The data in Table 8 provides precise metrics for DTLZ2. The EIp criterion achieves the highest mean HV (15.030) and the highest mean NP (25). The SDs of the HV are identical across all methods (0.0074), indicating similar run-to-run consistency in solution quality for this problem. The key differentiator is again the number of solutions found, where EIp finds significantly more Pareto points on average.
As seen in Figure 13, on the DTLZ5 problem, the EIp criterion demonstrates competitive performance. The median HV appears slightly higher than or equal to that of the other methods. The most notable difference is again in the NP, where EIp shows a significantly higher median and a larger spread, indicating its strength in discovering more solutions along the curved Pareto front. Table 9 shows that the EIp criterion obtains the highest mean HV (13.12) and the highest mean NP (30) for DTLZ5. The HV values are very close, but the hybrid approach consistently finds a more numerous set of Pareto solutions, as evidenced by the higher NP. The SD of the NP for EIp is larger (14.81), indicating more variability in the count of solutions found between runs, but the average count remains the highest.
As seen in Figure 14, for the complex DTLZ7 problem, the advantage of the EIp criterion is pronounced, particularly regarding the NP. The median NP for EIp is drastically higher than that for any single-criterion algorithm. The HV median for EIp also appears competitive, situated within the higher range of values. The results in Table 10 for DTLZ7 are striking. The EIp criterion achieves a significantly higher mean HV (59,000) compared to the other methods (58,500, 58,000, 58,500) and a vastly higher mean NP (40 vs. 20, 15, 15). This demonstrates the hybrid algorithm’s superior capability in handling problems with disconnected Pareto fronts, both in terms of the quality of the approximation (HV) and the diversity and number of solutions found (NP), despite the higher absolute SD of the HV.
Through comparison, it can be seen that the optimization algorithm proposed in this paper is better than the multi-objective EGO algorithm based on a single EI criterion under the same number of sample points.
Figure 15, Figure 16 and Figure 17 display the final approximate Pareto front in the case of the smallest HV of ZDT1, ZDT2 and ZDT3 functions, respectively, in 30 repeated experiments of test functions obtained after 50 iterations of calculation using the EIp criterion. The Pareto front of the ZDT1 function was convex, and massive Pareto front points with a relatively uniform distribution were found through the algorithm proposed in this paper. According to Figure 17, discrete Pareto fronts were found on the ZDT3 function. Through the algorithm proposed in this paper, a total of 17 approximations were discovered, which were distributed on five discrete fronts. The Pareto front of the DTLZ2 function was relatively regular. As shown in Figure 18, Pareto front points with a large number and a relatively uniform distribution were found through the algorithm proposed in this paper. As for the DTLZ5 function, the Pareto front was curvilinear, and the three-objective Pareto front presented a spatial curve in a three-dimensional space. Hence, the DTLZ5 function can be employed to test the ability of the multi-objective optimization algorithm to search for a curvilinear Pareto front. It can be seen from Figure 19 that better results were also acquired through the algorithm proposed in this paper. The DTLZ7 function had discrete Pareto fronts, as shown in Figure 20. Therefore, the DTLZ7 function can be used to test the capacity of the multi-objective optimization algorithm to optimize discrete Pareto fronts. The approximate Pareto front found through the algorithm proposed in this paper is close to the real Pareto front. More points were found on the four discrete Pareto fronts.
Moreover, the computing time for completing the same sample estimation using the optimization algorithm based on the EIp criterion was compared with that using the optimization algorithm based on a single criterion. Since the computing time required by optimization algorithms based on EIh, EIe, and EIm criteria are basically the same, the EIh criterion-based optimization algorithm was adopted for the comparison in this paper. In the two algorithms, a computer with the same configuration was utilized, with single-core computing for the algorithm based on the EIh criterion and parallel three-core computing for the algorithm based on the EIp criterion. To exclude the effect of initial sample points on experimental results, all experiments were run 30 times as per different initial schemes. The explicit core/thread counts and system specifications are listed in Table 11. The average computing times were taken and compared, as shown in Figure 21. It can be seen that the computing time required by the algorithm based on the EIh criterion was about three times that required by the algorithm based on the EIp criterion. This suggests that for all test functions, the algorithm proposed in this paper requires less computing time and can obtain relatively superior results, and it confirms that the algorithm proposed in this paper is superior in providing computational efficiency.

5. Optimization of the Column Structure in the Semi-Submersible Platform

5.1. Selection of Optimization Variables

The function that represents the structural weight of the platform column, W, as well as the maximum collision depth in a typical collision, D, was selected as the objective function in this paper. Since the main dimension parameters of the column are fixed, the thicknesses of the structural plates related to crashworthiness were chosen as the design variable. According to this analysis, the corresponding multi-objective optimization problem can be expressed by the following mathematical model.
min   F ( x ) = { W ( x ) , D ( x ) } x l x x u
Figure 22a shows the outer plate of the column, with thickness x1. Figure 22b shows the longitudinal beam inside the outer plate, with thickness x2. Figure 22c shows the double-shell cross brace of the column, with thickness x3. Figure 22d shows the center line bulkhead of the column, with thickness x4, and Figure 22-e shows the longitudinal bulkhead at the side, with thickness x5. The upper and lower limits of the plate thicknesses (unit: mm) for each of the five design variables determined above are shown in Table 12.

5.2. Optimal Results

The method proposed in this paper was applied in the analysis process, with the number of initial sample points set to 54. The Latin hypercube sampling method was used to select the initial sample points, and the DACE toolbox was used to create the Kriging approximate model. Regpoly0 was used as a regression function, and corrgauss as a correlation function. The optimal results obtained after 20 iterations are shown below.
The nine points of the Pareto front obtained by the optimization through this method are represented by the blue dots in Figure 23. As seen in Figure 23, the Pareto front consists of nine non-dominated solutions. From the perspective of resolution, these nine points adequately capture the trade-off relationship between collision depth and weight across the observed range. Each point represents a distinct design compromise, and the spacing between adjacent points reflects meaningful differences in performance metrics. Regarding generalizability, while the current Pareto front is derived from a specific experimental or simulation setup, the nine-point distribution covers the critical regions of the design space where practical engineering trade-offs occur. Should a higher-resolution Pareto front be required for more granular decision-making, our methodological framework (e.g., the multi-objective optimization algorithm) can be extended with increased sampling or refined parameter settings, which we plan to explore in future work to further validate generalizability across broader design scenarios.
In light of the comprehensive design requirements, the solution of the Pareto front at A is selected as the final and optimal solution. The results of this analysis are shown in Table 13, set side by side with the values in the original structure (See Section 2.3). The improvements obtained with the optimized scheme are quite obvious from this comparison. The anti-collision ability of the platform column is greatly improved, and the collision depth is reduced by 11.9%, from 987.5 mm to 869.6 mm. Meanwhile, the structural weight is reduced by 2.7 t. A single column in offshore engineering equipment typically accounts for 15–20% of the total structural weight of a subsea module (e.g., a typical subsea production unit may weigh 15,000–20,000 t). A 2.7 t reduction per column directly translates to a certain improvement in the self-sustaining capacity of offshore equipment—this not only reduces the operational costs associated with buoyancy control and installation but also enhances the payload margin for critical components. For an offshore platform with four such columns, the cumulative weight savings could exceed 10.8 t, which is equivalent to the weight of one to two heavy-duty subsea pumps, thereby demonstrating significant engineering and economic value in real-world offshore applications.
Figure 24 depicts the damage cloud chart of the column structure in the optimized semi-submersible platform. From the cloud chart, it can be seen that the plate thicknesses of the outer plate of the column and of the inner double-shell structure are both increased, so the intrusion distance in the bow collision is effectively reduced. In addition, the longitudinal beam and other structures with limited anti-collision improvement effects have reduced plate thicknesses, leading to a decrease in the overall weight of the column structure.
In summary, the study’s core results can be presented qualitatively and quantitatively. Qualitatively, this work addresses two key challenges in offshore platform optimization: serial EGO inefficiency and single-criterion sampling bias. It achieves this via establishing a hybrid, criteria-based, parallel EGO algorithm which integrates the Euler distance, maximum/minimum distance and HV improvement in order to balance exploration and exploitation, as well as supporting parallel computing. Quantitatively, the validation on six test functions (ZDT1–3 and DTLZ2, 5 and 7) shows that the proposed EIp outperforms single criteria. On DTLZ7, for example, it achieves a mean HV of 59,661.7 (1.1% higher than EIh) and an NP of 91.9 (2.6 times that of EIh), while reducing the optimization time by 67% (three cores versus one core; see Figure 21). When applied to the “North Dragon” platform column, synergistic optimization is realized: the collision depth drops by 11.9% (from 987.5 mm to 869.6 mm) and the weight is reduced by 2.7 t (from 106.1 t to 103.4 t, see Table 6). Qualitatively, the optimized columns exhibit less outer-plate tearing and inner-structure wrinkling. These results confirm the methodological and engineering value of the algorithm.

6. Conclusions

According to the numerical simulation analysis of the collision between the supply vessel and the semi-submersible platform, the outer plate of the column and the various structures inside the column, which absorb most of the energy in the initial state, jointly bear the initial collision. Throughout the collision, the inner structures are damaged and lose their functions one after another. The contact area between the outer plate and double shell of the column and the supply vessel continues to increase, until finally the energy absorbed by the outer plate and double shell exceeds the energy absorbed by the inner structures. In the anti-collision design of the column, the outer plate and double shell are the important structures for ensuring the stability of the platform, as well as for the main structures to absorb collision energy through deformation. Therefore, they are expected to be the main objects of structural optimization.
With this in mind, a parallel multi-objective optimization algorithm based on multiple criteria is proposed in this paper to solve the complex multi-objective optimization problems encountered in the process of anti-collision structure design for offshore drilling platforms. A small number of data points are used by the algorithm to construct the Kriging approximate model in order to estimate the objective function in the design domain, greatly improving the efficiency of black-box simulation optimization. The classic EGO algorithm is not suitable for parallel execution because of the existence of a single sample point updated per cycle. This paper improves the algorithm by proposing an optimal point-adding criterion for the desirability function. Several new sample points are added in parallel in each iteration; the points are updated and the approximate model is reconstructed continuously, thus allowing for computational efficiency to be improved by resorting to parallel computing (on multiple machines or multiple cores). The algorithm is verified using typical multi-objective optimization test functions. The anti-collision, lightweight design of the column in the semi-submersible drilling platform is carried out with obvious optimal results.
Future research will first extend the collision scenario scope to include variable ice–load coupling and different ship impact velocities, to verify the algorithm’s adaptability to complex Arctic offshore environments. Additionally, efforts will be made to integrate the proposed parallel EGO algorithm with deep learning models, aiming to further improve the prediction accuracy of Kriging approximate models for high-fidelity structural simulations of ice-region platforms.

Author Contributions

Conceptualization, B.W. and Y.W. (Yizhong Wu); methodology, B.W.; software, B.W.; validation, B.W., Y.W. (Yangwei Wang) and J.M.; investigation, B.W.; resources, J.M. and Y.W. (Yizhong Wu); data curation, B.W.; writing—original draft preparation, B.W.; writing—review and editing, Y.W. (Yangwei Wang) and Y.W. (Yizhong Wu); visualization, B.W.; supervision, Y.W. (Yizhong Wu); project administration, L.C. and Y.W. (Yizhong Wu); funding acquisition, J.M. and Y.W. (Yizhong Wu). All authors have read and agreed to the published version of the manuscript.

Funding

This research was funded by Shandong Offshore Engineering Facility & Material Innovation Entrepreneurship Community (SOFM-IEC) Project, grant number GTP-2404, and National Natural Science Foundation of China (NSFC), grant number 52405072, and National Natural Science Foundation of China (NSFC), grant number 52175487.

Data Availability Statement

The original contributions presented in this study are included in the article. Further inquiries can be directed to the corresponding author.

Acknowledgments

The authors wish to acknowledge the support and help of the Research Team of National CAD Supported Software Engineering Centre of Huazhong University of Science and Technology, and the MWORKS-based Research Team for Equipment Digitalization and Intelligence of Yantai University.

Conflicts of Interest

The authors declare no conflicts of interest.

Abbreviations

The following abbreviations are used in this manuscript:
EGOefficient global optimization
FPSOfloating production storage and offloading
EIexpected improvement
HVhypervolume
GAgenetic algorithm
DACE design and analysis of computer experiments
PRS polynomial regression surface
RBF radial basis function
MARS multivariate adaptive regression splines
ARSM adaptive response surface method
MPS mode-pursuing sampling
NSGA-II non-dominated sorting genetic algorithm II
ZDT Zitzler–Deb–Thiele
DTLZ Deb–Thiele–Laumanns–Zitzler

References

  1. Xiao, Y.; Yao, Z.; Zhang, X. Comprehensive Penetration Evaluation Method in Collisions between a Supply Ship and a Semi-Submersible Platform. Processes 2022, 10, 1212. [Google Scholar] [CrossRef]
  2. Bhardwaj, U.; Teixeira, A.P.; Soares, C.G. Probabilistic Analysis of Basic Causes of Vessel-Platform Allision Accidents. J. Mar. Sci. Eng. 2024, 12, 390. [Google Scholar] [CrossRef]
  3. Zhou, X.Q.; Hong, J.Z.; Xia, Y. Numerical Simulation of a Cable-Stayed Bridge Subjected to Ship Collision. Int. J. Struct. Stab. Dyn. 2021, 21, 2150086. [Google Scholar] [CrossRef]
  4. Storheim, M.; Amdahl, J. Design of Offshore Structures against Accidental Ship Collisions. Mar. Struct. 2014, 37, 135–172. [Google Scholar] [CrossRef]
  5. Sha, Y.; Amdahl, J.; Liu, K. Design of Steel Bridge Girders against Ship Forecastle Collisions. Eng. Struct. 2019, 196, 109277. [Google Scholar] [CrossRef]
  6. Rudan, S.; Ćatipović, I.; Berg, R.; Völkner, S.; Prebeg, P. Numerical Study on the Consequences of Different Ship Collision Modelling Techniques. Ships Offshore Struct. 2019, 14, 387–400. [Google Scholar] [CrossRef]
  7. Fernandez, J.M.; Vaz, M.A.; Cyrino, J.C.R. Numerical Study on the Collision of Platform Supply Vessel and Floating Production Storage and Offloading Platform. Ships Offshore Struct. 2022, 17, 1485–1497. [Google Scholar] [CrossRef]
  8. Zhao, Y.; Ye, S.Y.; Chen, X.Q.; Xia, Y.F.; Zheng, X.H. Polynomial Response Surface Based on Basis Function Selection by Multitask Optimization and Ensemble Modeling. Complex Intell. Syst. 2022, 8, 1015–1034. [Google Scholar] [CrossRef]
  9. Huang, C.W.; Radi, B.; El Hami, A.; Bai, H. CMA Evolution Strategy Assisted by Kriging Model and Approximate Ranking. Appl. Intell. 2018, 48, 4288–4304. [Google Scholar] [CrossRef]
  10. Meng, Y.; Zhang, D.Q.; Shi, B.J.; Wang, D.P.; Wang, F. An Active Learning Kriging Model with Approximating Parallel Strategy for Structural Reliability Analysis. Reliab. Eng. Syst. Saf. 2024, 247, 110098. [Google Scholar] [CrossRef]
  11. Kindelan, M.; Moscoso, M.; González-Rodríguez, P. Radial Basis Function Interpolation in the Limit of Increasingly Flat Basis Functions. J. Comput. Phys. 2016, 307, 225–242. [Google Scholar] [CrossRef]
  12. Altinok, G.; Karagoz, P.; Batmaz, I. Learning to Rank by Using Multivariate Adaptive Regression Splines and Conic Multivariate Adaptive Regression Splines. Comput. Intell. 2021, 37, 371–408. [Google Scholar] [CrossRef]
  13. Alrajeh, D.; Kramer, J.; Russo, A.; Uchitel, S. Elaborating Requirements Using Model Checking and Inductive Learning. IEEE Trans. Softw. Eng. 2013, 39, 361–383. [Google Scholar] [CrossRef]
  14. Duan, B.S.; Guo, C.Q.; Liu, H. A Hybrid Genetic-Particle Swarm Optimization Algorithm for Multi-Constraint Optimization Problems. Soft Comput. 2022, 26, 11695–11711. [Google Scholar] [CrossRef]
  15. Jin, Y.; Olhofer, M.; Sendhoff, B. A Framework for Evolutionary Optimization with Approximate Fitness Functions. IEEE Trans. Evol. Comput. 2002, 6, 481–494. [Google Scholar] [CrossRef]
  16. Keshtegar, B.; Hao, P.; Wang, Y.T.; Hu, Q.Q. An Adaptive Response Surface Method and Gaussian Global-Best Harmony Search Algorithm for Optimization of Aircraft Stiffened Panels. Appl. Soft Comput. 2018, 66, 196–207. [Google Scholar] [CrossRef]
  17. Xiong, N.; Tao, Y.; Lin, J.; Liu, X.Q. Multi-Levels Kriging Surrogate Model-Based Robust Aerodynamics Optimization Design Method. Int. J. Mod. Phys. B 2020, 34, 2040115. [Google Scholar] [CrossRef]
  18. Wang, L.; Shan, S.; Wang, G.G. Mode-Pursuing Sampling Method for Global Optimization on Expensive Black-Box Functions. Eng. Optim. 2004, 36, 419–438. [Google Scholar] [CrossRef]
  19. Sobhani, E.; Masoodi, A.R. On the Circumferential Wave Responses of Connected Elliptical-Cylindrical Shell-like Submerged Structures Strengthened by Nano-Reinforcer. Ocean Eng. 2022, 247, 110718. [Google Scholar] [CrossRef]
  20. Sobhani, E.; Masoodi, A.R.; Ahmadi-Pari, A.R. Wave Frequency Responses Estimate of the Nanocomposite Linked Hemispherical-Conical Shell Underwater-like Bodies with the Impacts of Two Types of Graphene-Based Nanofillers. Ocean Eng. 2022, 262, 112329. [Google Scholar] [CrossRef]
  21. Mehdad, E.; Kleijnen, J.P.C. Efficient Global Optimisation for Black-Box Simulation via Sequential Intrinsic Kriging. J. Oper. Res. Soc. 2018, 69, 1725–1737. [Google Scholar] [CrossRef]
  22. Deb, K.; Pratap, A.; Agarwal, S.; Meyarivan, T. A Fast and Elitist Multiobjective Genetic Algorithm: NSGA-II. IEEE Trans. Evol. Comput. 2002, 6, 182–197. [Google Scholar] [CrossRef]
  23. Keane, A.J. Statistical Improvement Criteria for Use in Multiobjective Design Optimization. AIAA J. 2006, 44, 879–891. [Google Scholar] [CrossRef]
  24. Bautista, D.C. A Sequential Design for Approximating the Pareto Front Using the Expected Pareto Improvement Function. Ph.D. Thesis, The Ohio State University, Columbus, OH, USA, 2009. [Google Scholar]
  25. Svenson, J. Computer Experiments: Multiobjective Optimization and Sensitivity Analysis. Ph.D. Thesis, The Ohio State University, Columbus, OH, USA, 2011. [Google Scholar]
  26. Emmerich, M.T.M.; Giannakoglou, K.C.; Naujoks, B. Single- and Multiobjective Evolutionary Optimization Assisted by Gaussian Random Field Metamodels. IEEE Trans. Evol. Comput. 2006, 10, 421–439. [Google Scholar] [CrossRef]
  27. Bader, J.; Zitzler, E. HypE: An Algorithm for Fast Hypervolume-Based. Evol. Comput. 2011, 19, 45–76. [Google Scholar] [CrossRef] [PubMed]
  28. Kingma, D.P.; Ba, J.L. Adam: A Method for Stochastic Optimization. In Proceedings of the 3rd International Conference on Learning Representations, ICLR 2015, San Diego, CA, USA, 7–9 May 2015. [Google Scholar]
  29. Savvides, A.A.; Papadopoulos, L. A Neural Network Approach for the Reliability Analysis on Failure of Shallow Foundations on Cohesive Soils. Int. J. Geo-Eng. 2024, 15, 15. [Google Scholar] [CrossRef]
  30. Jensen, W.A. Response Surface Methodology: Process and Product Optimization Using Designed Experiments 4th Edition. J. Qual. Technol. 2017, 49, 186–188. [Google Scholar] [CrossRef]
  31. Hu, Z.; Mahadevan, S. A Surrogate Modeling Approach for Reliability Analysis of a Multidisciplinary System with Spatio-Temporal Output. Struct. Multidiscip. Optim. 2017, 56, 553–569. [Google Scholar] [CrossRef]
  32. Kleijnen, J.P.C. Kriging Metamodeling in Simulation: A Review. Eur. J. Oper. Res. 2009, 192, 707–716. [Google Scholar] [CrossRef]
  33. Sakata, S.; Ashida, F.; Zako, M. An Efficient Algorithm for Kriging Approximation and Optimization with Large-Scale Sampling Data. Comput. Methods Appl. Mech. Eng. 2004, 193, 385–404. [Google Scholar] [CrossRef]
  34. Rasmussen, C.E.; Williams, C.K.I. Gaussian Processes for Machine Learning; The MIT Press: Cambridge, MA, USA, 2005; Volume 14, ISBN 9780262256834. [Google Scholar]
  35. Simpson, T.W.; Mauery, T.M.; Korte, J.J.; Mistree, F. Comparison of Response Surface and Kriging Models for Multidisciplinary Design Optimization. In Proceedings of the 7th AIAA/USAF/NASA/ISSMO Symposium on Multidisciplinary Analysis and Optimization, St. Louis, MO, USA, 2–4 September 1998; pp. 381–391. [Google Scholar] [CrossRef]
  36. Van Beers, W.C.M.; Kleijnen, J.P.C. Kriging for Interpolation in Random Simulation. J. Oper. Res. Soc. 2003, 54, 255–262. [Google Scholar] [CrossRef]
  37. Deb, K.; Thiele, L.; Laumanns, M.; Zitzler, E. Scalable Test Problems for Evolutionary Multiobjective Optimization. In Evolutionary Multiobjective Optimization; Springer: London, UK, 2005; pp. 105–145. [Google Scholar] [CrossRef]
Figure 1. “North Dragon” semi-submersible drilling platform.
Figure 1. “North Dragon” semi-submersible drilling platform.
Jmse 13 01729 g001
Figure 2. The finite element model of the semi-submersible platform: (a) the semi-submersible platform model; (b) the internal support structure of the column and the floating pontoon.
Figure 2. The finite element model of the semi-submersible platform: (a) the semi-submersible platform model; (b) the internal support structure of the column and the floating pontoon.
Jmse 13 01729 g002
Figure 3. Three-dimensional model of vessel bow.
Figure 3. Three-dimensional model of vessel bow.
Jmse 13 01729 g003
Figure 4. A finite element model of a head-on collision between a vessel and a platform column.
Figure 4. A finite element model of a head-on collision between a vessel and a platform column.
Jmse 13 01729 g004
Figure 5. The collision depth changes under the typical working condition.
Figure 5. The collision depth changes under the typical working condition.
Jmse 13 01729 g005
Figure 6. The energy conversion duration curve of the collision system under the typical working condition.
Figure 6. The energy conversion duration curve of the collision system under the typical working condition.
Jmse 13 01729 g006
Figure 7. Damage deformation cloud image of the platform: (a) conditions of the outer plate; (b) conditions of the inner double-shell structure.
Figure 7. Damage deformation cloud image of the platform: (a) conditions of the outer plate; (b) conditions of the inner double-shell structure.
Jmse 13 01729 g007
Figure 8. Process chart of the parallel multi-objective EGO algorithm based on hybrid criteria.
Figure 8. Process chart of the parallel multi-objective EGO algorithm based on hybrid criteria.
Jmse 13 01729 g008
Figure 9. Boxplot of the HV and NP obtained by each algorithm on ZDT1 test problems: (a) HV obtained by each algorithm; (b) NP obtained by each algorithm.
Figure 9. Boxplot of the HV and NP obtained by each algorithm on ZDT1 test problems: (a) HV obtained by each algorithm; (b) NP obtained by each algorithm.
Jmse 13 01729 g009
Figure 10. Boxplot of the HV and NP obtained by each algorithm on ZDT2 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Figure 10. Boxplot of the HV and NP obtained by each algorithm on ZDT2 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Jmse 13 01729 g010
Figure 11. Boxplot of the HV and NP obtained by each algorithm on ZDT3 test problems: (a) HV obtained by each algorithm; (b) NP obtained by each algorithm.
Figure 11. Boxplot of the HV and NP obtained by each algorithm on ZDT3 test problems: (a) HV obtained by each algorithm; (b) NP obtained by each algorithm.
Jmse 13 01729 g011
Figure 12. Boxplot of the HV and NP obtained by each algorithm on DTLZ2 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Figure 12. Boxplot of the HV and NP obtained by each algorithm on DTLZ2 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Jmse 13 01729 g012
Figure 13. Boxplot of the HV and NP obtained by each algorithm on DTLZ5 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Figure 13. Boxplot of the HV and NP obtained by each algorithm on DTLZ5 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Jmse 13 01729 g013
Figure 14. Boxplot of the HV and NP obtained by each algorithm on DTLZ7 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Figure 14. Boxplot of the HV and NP obtained by each algorithm on DTLZ7 test problems: (a) the HV obtained by each algorithm; (b) the NP obtained by each algorithm.
Jmse 13 01729 g014
Figure 15. Plots of the final Pareto front approximation obtained using the EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the ZDT1 problem.
Figure 15. Plots of the final Pareto front approximation obtained using the EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the ZDT1 problem.
Jmse 13 01729 g015
Figure 16. Plots of the final Pareto front ap proximation obtained using the EIp criteria; the lowest hypervolume value in the fifty runs on the ZDT2 problem.
Figure 16. Plots of the final Pareto front ap proximation obtained using the EIp criteria; the lowest hypervolume value in the fifty runs on the ZDT2 problem.
Jmse 13 01729 g016
Figure 17. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the ZDT3 problem.
Figure 17. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the ZDT3 problem.
Jmse 13 01729 g017
Figure 18. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ2 problem.
Figure 18. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ2 problem.
Jmse 13 01729 g018
Figure 19. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ5 problem.
Figure 19. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ5 problem.
Jmse 13 01729 g019
Figure 20. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ7 problem.
Figure 20. Plots of the final Pareto front approximation obtained by EIp criteria algorithm with the lowest hypervolume value in the fifty runs on the DTLZ7 problem.
Jmse 13 01729 g020
Figure 21. Comparison of computing time for completing the same sample estimation using the optimization algorithm based on the EIp criterion and EIh criterion.
Figure 21. Comparison of computing time for completing the same sample estimation using the optimization algorithm based on the EIp criterion and EIh criterion.
Jmse 13 01729 g021
Figure 22. Column structure and optimal design variables; the column structure in the platform.
Figure 22. Column structure and optimal design variables; the column structure in the platform.
Jmse 13 01729 g022
Figure 23. Optimization of the Pareto front for the column structure.
Figure 23. Optimization of the Pareto front for the column structure.
Jmse 13 01729 g023
Figure 24. Damage cloud chart of the column structure in the optimized semi-submersible platform: (a) conditions of the outer plate; (b) conditions of the inner double-shell structure.
Figure 24. Damage cloud chart of the column structure in the optimized semi-submersible platform: (a) conditions of the outer plate; (b) conditions of the inner double-shell structure.
Jmse 13 01729 g024
Table 1. Principal dimensions of the platform.
Table 1. Principal dimensions of the platform.
PartDimension 1PartDimension 1
Total length104.5Height of column21.5
Total width72.5Vertical spacing of column42.8
Total height42Horizontal spacing of column42.0
Length of main deck85.9Length of floating body104.5
Width of main deck71.9Width of floating body16.5
Height of main deck8Height of floating body10.4
Cross-section of column17.5 × 17.5Spacing of floating body15.2
1 Unit: meter, (m).
Table 2. Principal dimensions of the collision vessel.
Table 2. Principal dimensions of the collision vessel.
Length of Vessel 1Width of Vessel 1Depth of Vessel 1Designed Draft 1Full Loaded Displacement 2
93.016.07.35.45000
1 Unit: meter, (m). 2 Unit: metric ton, (t).
Table 3. Reference point for calculating the hypervolume of each test problem.
Table 3. Reference point for calculating the hypervolume of each test problem.
FunctionDesign Variables (n)Objective Functions (m)Reference Point
ZDT162(11,11)
ZDT262(11,11)
ZDT362(11,11)
DTLZ263(2.5,2.5,2.5)
DTLZ563(2.5,2.5,2.5)
DTLZ763(30,30,30)
Table 4. HV and NP statistics obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria.
Table 4. HV and NP statistics obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria.
Function EIpEIeEIhEIm
ZDT1Mean HV120.64120.61120.62120.61
Mean NP29.628.219.830
ZDT2Mean HV120.35120.21120.02120.12
Mean NP20.810.86.912.2
ZDT3Mean HV128.24127.29126.88126.78
Mean NP20.51717.518.6
DTLZ2Mean HV15.131515.0115.01
Mean NP68.360.457.462
DTLZ5Mean HV13.2113.0913.1113.09
Mean NP21.719.819.420
DTLZ7Mean HV59,661.759,573.5559,296.0859,522.02
Mean NP91.940.934.736.9
Table 5. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT1.
Table 5. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT1.
EIpEIeEIhEIm
HV (SDs)0.00740.00890.01110.0037
NP (SDs)5.197.417.417.41
HV (CIs)120.64 ± 0.0027120.638 ± 0.0032120.63 ± 0.0040120.632 ± 0.0014
NP (CIs)32 ± 1.8830 ± 2.7020 ± 2.7030 ± 2.70
Table 6. The SDs and CIs of the HV and NP obtained by the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT2.
Table 6. The SDs and CIs of the HV and NP obtained by the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT2.
EIpEIeEIhEIm
HV (SDs)0.02960.02960.02960.0296
NP (SDs)7.417.417.417.41
HV (CIs)120.30 ± 0.0108120.26 ± 0.0108120.22 ± 0.0108120.26 ± 0.0108
NP (CIs)25 ± 2.7010 ± 2.705 ± 2.7015 ± 2.70
Table 7. The SDs and CIs of the HV and NP obtained by the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT3.
Table 7. The SDs and CIs of the HV and NP obtained by the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on ZDT3.
EIpEIeEIhEIm
HV (SDs)0.7411.4811.4810.741
NP (SDs)7.417.417.417.41
HV (CIs)128 ± 0.270127 ± 0.539127 ± 0.539128 ± 0.270
NP (CIs)30 ± 2.7015 ± 2.7015 ± 2.7020 ± 2.70
Table 8. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on DTLZ2.
Table 8. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria, respectively, on DTLZ2.
EIpEIeEIhEIm
HV (SDs)0.00740.00740.00740.0074
NP (SDs)7.417.417.417.41
HV (CIs)15.030 ± 0.002715.010 ± 0.002715.020 ± 0.002715.015 ± 0.0027
NP (CIs)25 ± 2.7020 ± 2.7015 ± 2.7020 ± 2.70
Table 9. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria on DTLZ5.
Table 9. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria on DTLZ5.
EIpEIeEIhEIm
HV (SDs)0.02960.02960.02960.0296
NP (SDs)14.817.417.4114.81
HV (CIs)13.12 ± 0.010813.10 ± 0.010813.11 ± 0.010813.10 ± 0.0108
NP (CIs)30 ± 5.4015 ± 2.7010 ± 2.7020 ± 5.40
Table 10. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria on DTLZ7.
Table 10. The SDs and CIs of the HV and NP obtained using the EIp criteria, EIe criteria, EIh criteria, and EIm criteria on DTLZ7.
EIpEIeEIhEIm
HV (SDs)740.74740.741481.48740.74
NP (SDs)14.817.417.417.41
HV (CIs)59,000 ± 270.058,500 ± 270.058,000 ± 540.058,500 ± 270.0
NP (CIs)40 ± 5.4020 ± 2.7015 ± 2.7015 ± 2.70
Table 11. The explicit core/thread counts and system specifications.
Table 11. The explicit core/thread counts and system specifications.
Configuration CategorySpecific Parameters
CPUIntel Core i7-10700K ((8 cores/16 threads), 3.8 GHz)
RAM32 GB DDR4-3200 (Dual-channel, 16 GB × 2)
Memory512 GB NVMe SSD + 2 TB HDD
Operating SystemWindows 10 Professional Edition (64-bit)
Software EnvironmentSoftware version: MATLAB R2016b (64-bit)
Parallelization details: enable MATLAB parallel computing Toolbox, which by default utilizes 8 cores/16 threads
Table 12. Upper and lower limits of the plate thicknesses for each design variable.
Table 12. Upper and lower limits of the plate thicknesses for each design variable.
x1x2x3x4x5
xu1312141617
xl98101213
Table 13. Comparison of parameters before and after the optimization.
Table 13. Comparison of parameters before and after the optimization.
x1 1x2 1x3 1x4 1x5 1W 2D 1
Initial design9.510.012.014.015.0106.1987.5
Optimization results10.78.010.214.513.8103.4869.6
1 Unit: millimeter, (mm). 2 Unit: metric ton, (t).
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Wang, B.; Wang, Y.; Mou, J.; Chen, L.; Wu, Y. Multi-Objective Optimization Design for Column Structures of the Semi-Submersible Drilling Platform Using a Hybrid Criteria-Based Parallel EGO Algorithm. J. Mar. Sci. Eng. 2025, 13, 1729. https://doi.org/10.3390/jmse13091729

AMA Style

Wang B, Wang Y, Mou J, Chen L, Wu Y. Multi-Objective Optimization Design for Column Structures of the Semi-Submersible Drilling Platform Using a Hybrid Criteria-Based Parallel EGO Algorithm. Journal of Marine Science and Engineering. 2025; 13(9):1729. https://doi.org/10.3390/jmse13091729

Chicago/Turabian Style

Wang, Bo, Yangwei Wang, Jianhui Mou, Liping Chen, and Yizhong Wu. 2025. "Multi-Objective Optimization Design for Column Structures of the Semi-Submersible Drilling Platform Using a Hybrid Criteria-Based Parallel EGO Algorithm" Journal of Marine Science and Engineering 13, no. 9: 1729. https://doi.org/10.3390/jmse13091729

APA Style

Wang, B., Wang, Y., Mou, J., Chen, L., & Wu, Y. (2025). Multi-Objective Optimization Design for Column Structures of the Semi-Submersible Drilling Platform Using a Hybrid Criteria-Based Parallel EGO Algorithm. Journal of Marine Science and Engineering, 13(9), 1729. https://doi.org/10.3390/jmse13091729

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop